paper_id
stringlengths
9
16
version
stringclasses
26 values
yymm
stringclasses
311 values
created
timestamp[s]
title
stringlengths
6
335
secondary_subfield
sequencelengths
1
8
abstract
stringlengths
25
3.93k
primary_subfield
stringclasses
124 values
field
stringclasses
20 values
fulltext
stringlengths
0
2.84M
1707.07362
1
1707
2017-07-23T23:10:35
Detecting Topological Changes in Dynamic Community Networks
[ "cs.SI", "cs.DM", "physics.soc-ph" ]
The study of time-varying (dynamic) networks (graphs) is of fundamental importance for computer network analytics. Several methods have been proposed to detect the effect of significant structural changes in a time series of graphs. The main contribution of this work is a detailed analysis of a dynamic community graph model. This model is formed by adding new vertices, and randomly attaching them to the existing nodes. It is a dynamic extension of the well-known stochastic blockmodel. The goal of the work is to detect the time at which the graph dynamics switches from a normal evolution -- where balanced communities grow at the same rate -- to an abnormal behavior -- where communities start merging. In order to circumvent the problem of decomposing each graph into communities, we use a metric to quantify changes in the graph topology as a function of time. The detection of anomalies becomes one of testing the hypothesis that the graph is undergoing a significant structural change. In addition the the theoretical analysis of the test statistic, we perform Monte Carlo simulations of our dynamic graph model to demonstrate that our test can detect changes in graph topology.
cs.SI
cs
Detecting Topological Changes in Dynamic Community Networks ∗ Peter Wills and François G. Meyer [email protected], [email protected] Applied Mathematics & Electrical Engineering University of Colorado at Boulder, Boulder CO 80305 Abstract The study of time-varying (dynamic) networks (graphs) is of fundamental importance for computer network analytics. Several methods have been proposed to detect the e(cid:29)ect of signi(cid:27)cant structural changes in a time series of graphs. The main contribution of this work is a detailed analysis of a dynamic community graph model. This model is formed by adding new vertices, and randomly attaching them to the existing nodes. It is a dynamic extension of the well-known stochastic blockmodel. The goal of the work is to detect the time at which the graph dynamics switches from a normal evolution -- where balanced communities grow at the same rate -- to an abnormal behavior -- where communities start merging. In order to circumvent the problem of decomposing each graph into communities, we use a metric to quantify changes in the graph topology as a function of time. The detection of anomalies becomes one of testing the hypothesis that the graph is undergoing a signi(cid:27)cant structural change. In addition the the theoretical analysis of the test statistic, we perform Monte Carlo simulations of our dynamic graph model to demonstrate that our test can detect changes in graph topology. Introduction 1 The study of time-varying (dynamic) networks (or graphs) is of fundamental importance for computer network analytics and the detection of anomalies associated with cyber crime [20, 22, 25]. Dynamic graphs also provide models for social networks [2, 14], and are used to decode the functional connectivity in neuroscience [16, 21, 46] and biology [5]. The signi(cid:27)cance of this research topic has triggered much recent work [3, 30, 43]. Several methods have been proposed to detect the e(cid:29)ect of signi(cid:27)cant structural changes (e.g., changes in topology, connectivity, or relative size of the communities in a community graph) in a time series of graphs. We focus on networks that change over time, allowing both edges and nodes to be added or removed. We refer to these as dynamic networks. A fundamental goal of the study of dynamic graphs is the identi(cid:27)cation of universal patterns that uniquely couple the dynamical processes that drive the evolution of the connectivity with the speci(cid:27)c topology of the network; in essence the discovery of universal spatio-temporal patterns [29, 24]. In this context, the goal of the present work is to detect anomalous changes in the evolution of dynamic graphs. We propose a novel statistical method, which captures the coherence of the dynamics under baseline (normal) evolution of the graph, and can detect switching and regime transitions triggered by anomalies. Speci(cid:27)cally, we study a mathematical model of normal and abnormal growth of a community network. Dynamic community networks have recently been the topic of several studies [50, 4, 8, 12, 27, 35, 37]. The simplest incarnation of such models, a dynamic stochastic blockmodel [48, 53, 55, 54, 56, 52, 40, 19], is the ∗This work was supported by NSF DMS 1407340. 1 subject of our study. These graph models have a wide range of applications, ranging from social networks [23, 57, 34, 49, 39, 17, 18, 31] to computer networks [41, 47] and even biology and neuroscience [32]. In order to circumvent the problem of decomposing each graph into simpler structures (e.g., communities), we use a metric to quantify changes in the graph topology as a function of time. The detection of anomalies becomes one of testing the hypothesis that the graph is undergoing a signi(cid:27)cant structural change. Several notions of similarity have been proposed to quantify the structural similitude without resorting to the computation of a true distance (e.g., [6, 28] and references therein). Unlike a true metric, a similarity is typically not injective (two graphs can be perfectly similar without being the same), and rarely satis(cid:27)es the triangle inequality. This approach relies on the construction of a feature vector that extracts a signature of the graph characteristics; the respective feature vectors of the two graphs are then compared using a distance, or a kernel. In the extensive review of Koutra et al. [28], the authors studied several graph similarities and distances. They concluded that existing similarities and distances either fail to conform to a small number of well-founded axioms, or su(cid:29)er from a prohibitive computational cost. In response to these shortcomings, Koutra et al. proposed a novel notion of similarity [28]. Inspired by the work of [28], we proposed in [38] a true metric that address some of the limitations of the DeltaCon similarity introduced in [28]. We emphasize that it is highly preferable to have a proper metric, rather than an informal distance, when comparing graphs; this allows one to employ proof techniques not available in the absence of the triangle inequality. Our distance, coined the resistance-perturbation distance, can quantify structural changes occurring on a graph at di(cid:29)erent scales: from the local scale formed by the neighbors of each vertex, to the largest scale that quanti(cid:27)es the connections between clusters, or communities. Furthermore, we proposed fast (linear in the number of edges) randomized algorithms that can quickly compute an approximation to the graph metric, for which error bounds are proven (in contrast to the DeltaCon algorithm given in [28], which has a linear time approximate algorithm but for which no error bounds are given). The main contribution of this work is a detailed analysis of a dynamic community graph model, which we call the dynamic stochastic blockmodel. This model is formed by adding new vertices, and randomly attaching them to the existing nodes. The goal of the work is to detect the time at which the graph dynamics switches from a normal evolution -- where two balanced communities grow at the same rate -- to an abnormal behavior -- where the two communities are merging. Because the evolution of the graph is stochastic, one expects random (cid:30)uctuations of the graph geometry. The challenge is to detect an anomalous event under normal random variation. We propose an hypothesis test to detect the abnormal growth of the balanced stochastic blockmodel. In addition to the theoretical analysis of the test statistic, we conduct several experiments on synthetic networks, and we demonstrate that our test can detect changes in graph topology. The remainder of this paper is organized as follows. In the next section we introduce the main mathe- matical concepts and corresponding nomenclature. In section 3 we recall the de(cid:27)nition of the resistance perturbation distance. We provide a straightforward extension of the metric to graphs of di(cid:29)erent sizes and disconnected graphs. In section 4 we formally de(cid:27)ne the problem, we introduce the dynamic balanced two-community stochastic blockmodel. We describe the main contributions and the line of attack in Section 5. In Section 6 we present the results of experiments conducted on synthetic dynamic networks, followed by a short discussion in Section 7. 2 Preliminaries and Notation We denote by G = (V , E) an undirected, unweighted graph, where V is the vertex set of size n, and E is the edge set of size m. We will often use u, v, or w to denote vertices in V . For an edge e ∈ E, we denote by endpoints(e) the subset of V formed by the two endpoint of e. 2 We use the standard asymptotic notation; see Appendix A for details. Given a family of probability spaces Ω = {Ωn, Probn}, and a sequence of events E = {En}, we write that Ω has the property with high probability ("w.h.p."), if limn→∞ Prob(En) = 1. When there is no ambiguity, we use the following abbreviated summation notation,  u≤n n u=1 and  u <v ≤n n n u=1 v =u+1 . is short for is short for Table B in Appendix B provides a list of the main notations used in the paper. 2.1 E(cid:29)ective Resistance We brie(cid:30)y review the notion of e(cid:29)ective resistance [26, 10, 13, 11] on a connected graph. The reader familiar with the concept can jump to the next section. There are many di(cid:29)erent ways to present the concept of e(cid:29)ective resistance. We use the electrical analogy, which is very standard (e.g., [10]). Given an unweighted graph G = (V , E), we transform G into a resistor network by replacing each edge e by a resistor with unit resistance. De(cid:27)nition 1 (E(cid:29)ective resistance [26]). The e(cid:29)ective resistance(cid:98)Ruv between two vertices u and v in V is We denote by(cid:98)R the n × n matrix with entries(cid:98)Ruv , u, v = 1, . . . , n. de(cid:27)ned as the voltage applied between u and v that is required to maintain a unit current through the terminals formed by u and v. The relevance of the e(cid:29)ective resistance in graph theory stems from the fact that it provides a distance on a graph [26] that quanti(cid:27)es the connectivity between any two vertices, not simply the length of the shortest path. Changes in e(cid:29)ective resistance reveal structural changes occurring on a graph at di(cid:29)erent scales: from the local scale formed by the neighbors of each vertex, to the largest scale that quanti(cid:27)es the connections between clusters, or communities. 3 Resistance Metrics 3.1 The Resistance Perturbation Metric The e(cid:29)ective resistance can be used to track structural changes in a graph, and we use it to de(cid:27)ne a distance between two graphs on the same vertex set [38] (see also [45] for a similar notion of distance). Formally, we de(cid:27)ne the Resistance Perturbation Distance as follows. De(cid:27)nition 2 (Resistance Perturbation Distance). Let G(1) = (V , E(1)) and G(2) = (V , E(2)) be two connected, respectively. The RP-p distance between G(1) and G(2) is de(cid:27)ned as the element-wise p-norm of the di(cid:29)erence between their e(cid:29)ective resistance matrices. For 1 ≤ p < ∞, unweighted, undirected graphs on the same vertex set, with respective e(cid:29)ective resistance matrices,(cid:98)R(1) and(cid:98)R(2) (cid:13)(cid:13)(cid:13)(cid:98)R (2)(cid:13)(cid:13)(cid:13)p (1) −(cid:98)R = (cid:34) i, j∈V (cid:12)(cid:12)(cid:12)(cid:98)R ij −(cid:98)R (1) (2) ij (cid:12)(cid:12)(cid:12)p(cid:35)1/p . RPp(G (1) , G (2)) = (3.1) In this paper, we will restrict our attention to the RP1 distance (we will omit the subscript p = 1), because it is directly analogous to the Kirchho(cid:29) index. 3 3.2 Extending the Metric to Disconnected Graphs The resistance metric is not properly de(cid:27)ned when the vertices are not within the same connected component. To remedy this, we use a standard approach. Letting(cid:98)Ruv denote the e(cid:29)ective resistance between two vertices u and v in a graph, then the conductivity Cu v =(cid:98)R−1 quantity (1 +Cu v)−1. Note that (1 +Cu v)−1 =(cid:98)Ru v/((cid:98)Ru v +1), and so we can de(cid:27)ne this new quantity relative uv can be de(cid:27)ned to be zero for vertices in disconnected components. Considering the conductivity as a similarity measure on vertices, a distance is given by the to the e(cid:29)ective resistance without any reference to the conductance. We refer to the resulting quantity as the renormalized e(cid:29)ective resistance. De(cid:27)nition 3 (Renormalized E(cid:29)ective Resistance). Let G = (V , E) be a graph (possibly disconnected). We de(cid:27)ne the renormalized e(cid:29)ective resistance between any two vertices u and v to be if u and v are connected, otherwise, Ru v = 1 where(cid:98)Ru v is the e(cid:29)ective resistance between u and v, and β > 0 is an arbitrary constant. n = V . Let R(1) and R(2) denote the renormalized e(cid:29)ective resistances in(cid:103)G(1) = (V , E(1)) and(cid:103)G(2) = (V , E(2)) De(cid:27)nition 4 (Renormalized Resistance Distance). Let G(1) = (V (1), E(1)) and G(2) = (V (2), E(2)) be two graphs (with possibly di(cid:29)erent vertex sets). We consider V = V (1)∪V (2), and relabel the union of vertices using [n], where We now proceed to extend the notion of resistance perturbation distance. (3.2) (cid:40)(cid:98)Ru v/((cid:98)Ru v + β) where the parameter β (see (3.2)) is implicitly de(cid:27)ned. In the rest of the paper we work with β = 1, and dispense of the subscript β in (3.3). In other words, the e(cid:29)ective resistance before applying the function x → x/(1 + x). Note that when(cid:98)R (cid:28) β, then R ≈(cid:98)R/β, i.e. Remark 1. An additional parameter β has been added to the de(cid:27)nition. Changing β is equivalent to scaling the renormalized resistance is approximately a rescaling of the e(cid:29)ective resistance. Note that in this metric, two graphs are equal if they di(cid:29)er only in addition or removal of isolated vertices. The following lemma con(cid:27)rms that the distance de(cid:27)ned by (3.3) remains a metric when we compare graphs with the same vertex set. Lemma 1. Let V be a vertex set. RD de(cid:27)ned by (3.3) us a metric on the space of unweighted undirected graphs de(cid:27)ned on the same vertex set V . Remark 2. The metric given in De(cid:27)nition 4 can be used to compare graphs of two di(cid:29)erent sizes, by adding isolated vertices to both graphs until they have the same vertex set (this is why we must form the union V = V (1) ∪ V (2) and compare the graphs over this vertex set). This method will give reasonable results when the overlap between V (1) and V (2) is large. In particular, if we are comparing graphs of size n and n + 1, then we only need add one isolated vertex to the former so that we can compare it to the latter. This situation is illustrated in Figure 3.1. 4 respectively. We de(cid:27)ne the renormalized resistance distance to be RDβ(G (1) , G (1) u v − R (2) u v (cid:12)(cid:12)(cid:12) . (2)) =  u <v ≤n (cid:12)(cid:12)(cid:12)R RD def= RD1 . (3.3) (3.4) Figure 3.1: In order to compare Gn and Gn+1, we include node n + 1 into Gn (see left), and evaluate the renormalized e(cid:29)ective resistance on the augmented graph, with vertex set {1, . . . , n} ∪ {n + 1}. When the graphs G(1) and G(2) have di(cid:29)erent sizes, the distance RD still satis(cid:27)es the triangle inequality, and is symmetric. However, RD is no longer injective: it is a pseudo-metric. Indeed, as explained in the following lemmas, if RD(G(1), G(2)) = 0, then the connected components of G(1) and G(2) are the same, but the respective vertex sets may di(cid:29)er by an arbitrary number of isolated vertices. Lemma 2. Let G = (E, V) be an unweighted undirected graph, and let V (i) be a set of isolated vertices, to wit V (i) ∩ V = ∅ and ∀e ∈ E, endpoints(e) (cid:60) V (i). De(cid:27)ne G(cid:48) = (V ∪ V (i), E), then we have RD(G, G(cid:48)) = 0. The following lemma shows that the converse is also true. Lemma 3. Let G(1) = (V , E(1)) and G(2) = (V , E(2)) be two unweighted, undirected graphs, where V (1) > V (2). If RD(G(1), G(2)) = 0, then E(1) = E(2). Furthermore, there exists a set V (i) of isolated vertices, such that V (1) = V (2) ∪ V (i). In summary, in this work the distance RD will always be a metric since we will only consider graphs that are connected with high probability. 4 Graph Models In our analysis, we will discuss two common random graph models, the classic model of Erdős and Rényi [7] and the stochastic blockmodel [1]. De(cid:27)nition 5 (Erdős-Rényi Random Graph [7]). Let n ∈ (cid:78) and let p ∈ [0, 1]. We recall that the Erdős-Rényi random graph, (cid:71)(n, p), is the probability space formed by the graphs de(cid:27)ned on the set of vertices [n], where edges are drawn randomly from independent Bernoulli random variables with probability p. In e(cid:29)ect, a graph G ∼ (cid:71)(n, p), with m edges, occurs with probability (cid:18)n (cid:19) 2 Prob(G) = pm(1 − p)(n 2)−m . (4.1) De(cid:27)nition 6. Let G = (V , E) ∼ (cid:71)(N , p). For any vertex u ∈ V , we denote by du the degree of u; we also denote by dn = (n − 1)p the expected value of du. We now introduce a model of a dynamic community network: the balanced, two-community stochastic blockmodel. De(cid:27)nition 7 (Dynamic Stochastic Blockmodel). Let n ∈ (cid:78), and let p, q ∈ [0, 1]. We denote by (cid:71)(n, p, q) the probability space formed by the graphs de(cid:27)ned on the set of vertices [n], constructed as follows. 5 We split the vertices [n] into two communities C1 and C2, formed by the odd and the even integers in [n] respectively. We denote by n1 = (cid:98)(n + 1)/2(cid:99) and n2 = (cid:98)n/2(cid:99) the size of C1 and C2 respectively. Edges within each community are drawn randomly from independent Bernoulli random variables with probability p. Edges between communities are drawn randomly from independent Bernoulli random variables with probability q. For G ∈ (cid:71)(n, p, q), with m1 and m2 edges in communities C1 and C2 respectively, we have (4.2) Prob(G) = pm1(1 − p)(m1 2 )−m1qm2(1 − q)(m2 2 )−m2 . Remark 3. Although we use (cid:71) for both random graph models, the presence of two or three parameters prevents ambiguity in our de(cid:27)nitions. De(cid:27)nition 8. Let G ∼ (cid:71)(n, p, q). We denote by dn1 = pn1 the expected degree within community C1, and by dn2 = pn2 the expected degree within community C2. We denote by kn the binomial random variables that counts the number of cross-community edges between C1 and C2. Because asymptotically, n1 ∼ n2, we ignore the dependency of the expected degree on the speci(cid:27)c community when computing asymptotic behaviors for large n. More precisely, we have the following results. Lemma 4. Let Gn ∈ (cid:71)(n, p, q). We have 1. dn1 = dn2 + εp, where ε = 0 if n is even, or ε = 1 otherwise. 2 2 2(1 + (cid:111) (1)). 2. dn 1 = dn 1 1 (1 + (cid:111) (1)). 3. = 2 1 dn 1 2 2 dn 1 = dn1 dn2 (cid:32) 1 (cid:33) 2 dn 4. + (cid:79) where dn = dn1, or dn = dn2. 2(cid:17) (cid:16)1/dn In summary, in the remaining of the text we loosely write 1/dn when either 1/dn1 or 1/dn2 could be used, and the error between the two terms is no larger than (cid:79) . Remark 4. In this work, we study nested sequences of random graphs, and we use sometime the subscript n to denote the index of the corresponding element Gn in the graph process. Remark 5. While our model assumes that the two communities have equal size, or di(cid:29)er at most by one vertex, the model can be extended to multiple communities of various sizes. 6 Figure 4.1: Left: the dynamic stochastic blockmodel Gn is comprised of two communities (C1: red and C2: blue). As a new (magenta) vertex is added, the new graph Gn+1 can remain structurally the same -- if no new edges are created between C1 and C2 (top right) -- or can become structurally di(cid:29)erent if the communities start to merge with the addition of new edges between C1 and C2 (bottom right). 5 Main Results Informal Presentation of our Results 5.1 Before carefully stating the main result in the next subsection, we provide a back of the envelope analysis to help understand under what circumstances the resistance metric can detect an anomalous event in the dynamic growth of a stochastic blockmodel. In particular, we aim to detect whether cross-community edges are formed at a given timestep. In graphs with few cross-community edges, the addition of such an edge changes the geometry of the graph signi(cid:27)cantly. We will show that the creation of such edges can be detected with high probability when the average in-community degree dominates the number of cross-community edges. Figure 4.1 illustrates the statement of the problem. As a new vertex (shown in magenta) is added to the graph Gn, the connectivity between the communities can increase, if edges are added between C1 and C2, or the communities can remain separated, if no cross-community edges are created. If the addition of the new vertex promotes the merging of C1 and C2, then we consider the new graph Gn+1 to be structurally di(cid:29)erent from Gn, otherwise Gn+1 remains structurally the same as Gn (see Fig. 4.1). The goal of the present work is to detect the fusion of the communities without identifying the com- munities. We show that the e(cid:29)ective resistance yields a metric that is sensitive to changes in pattern of connections and connectivity structure between C1 and C2. Therefore it can be used to detect structural changes between Gn and Gn+1 without detecting the structure present in Gn. The informal derivation of our main result relies on the following three ingredients: 1. each community in (cid:71)(n, p, q) is approximately a "random graph" (Erdős-Rényi ), (cid:71)(n/2, p); 2. the e(cid:29)ective resistance between two vertices u, v within (cid:71)(n/2, p) is concentrated around 2/dn = 2/(p(n/2 − 1); cross-community edges,(cid:98)Ruv ≈ 1/kn. 3. the e(cid:29)ective resistance between u ∈ C1 and v ∈ C2 depends only on the bottleneck formed by the kn 7 UnGn+1Gn+1is structurally differentn+1V= Vis structurally the samen{ }G We now proceed with an informal analysis of the changes in e(cid:29)ective resistance distance when the new vertex, n + 1, is added to the stochastic blockmodel Gn (see Fig. 4.1). We (cid:27)rst consider the "null hypothesis" where no cross-community edges is formed when vertex n + 1 is added to the graph. All edges are thus created in the community of n + 1, say C1 (without any loss of generality). Roughly pn/2 new edges are created, and thus about (cid:79) (n) vertices are a(cid:29)ected by the addition of these new edges to C1. Because the e(cid:29)ective resistance between any two vertices u, v in C1 is concentrated around 2/[p(n1 − 1 + 1)] ≥ 2/(dn + 1), the changes in resistance after the addition of vertex n + 1 is bounded by ∆(cid:98)Ruv ≤ 2 dn (cid:33) (cid:32) 1 dn − 2 dn + 1 = (cid:79) 2 . (5.1) Although, one would expect that only vertices in community C1 (wherein n + 1 has been added) be a(cid:29)ected by this change in e(cid:29)ective resistance, a more detailed analysis shows that vertices in C2 slightly bene(cid:27)t of the increase in connectivity within C1. e(cid:29)ective resistances. Nevertheless, the most signi(cid:27)cant perturbation in(cid:98)Ruv occurs for the n/2 × n/2 pairs We now consider the alternate hypothesis, where at least one cross-community edge is formed after adding n + 1 (see Fig. 4.1-bottom right). This additional cross-community edge has an e(cid:29)ect on all pairwise of vertices in C1 × C2. Indeed, if u ∈ C1 and v ∈ C2, the change in e(cid:29)ective resistance becomes ∆(cid:98)Ruv ≈ 1 kn − 1 kn + 1 = (cid:79) (cid:19) (cid:18) 1 2 n k . (5.2) In summary, we observe asymptotic separation of the two regimes precisely when kn/dn → 0, which occurs with high probability when n · qn = (cid:111) (pn). We should therefore be able to use the renormalized resistance distance to test the null hypothesis that no edge is added between C1 and C2, and that Gn and Gn+1 are structurally the same. We will now introduce the main character of this work: the dynamic stochastic block model, and we will then provide a precise statement of the result. In particular, we hope to elucidate our model of a dynamic community graph, in which at each time step a new vertex joins the graph and forms connections with previous vertices. The idea of graph growth as a generative mechanism is commonplace for models such as preferential attachment, but is less often seen in models such as Erdős-Rényi and the stochastic blockmodel. 5.2 The Growing Stochastic Blockmodel We have described in De(cid:27)nition 7 a model for a balanced stochastic block model, where the probabilities of connections p and q are (cid:27)xed. However, we are interested in the regime of large graphs (n → ∞), where p and q cannot remain constant. In fact the probabilities of connection, within each community and across communities go to zero as the size of the graph, n, goes to in(cid:27)nity. The elementary growth step, which transforms Gn = (Vn, En) into Gn+1 = (En+1, Vn+1) proceeds as follows: one adds a vertex n + 1 to Vn to form Vn+1, assigns this new vertex to C1 or C2 according to the parity of n. One then connects n + 1 to each member of its community with probability p and each member of the opposite community with probability q. This leads to a new set of vertices, En+1. 8 probabilities of connection {p1, q1} {p2, q2} {p3, q3} ... G G G (1) 1 (2) 1 (3) 1 ... G growth sequence to generate Gn (1) 2 (2) 2 (3) 2 ... (2) 3 (3) 3 ... G G G G de(cid:27)nition of Gn de(cid:27)nition of Dn G2 G3 G4 (1) 2 (2) 3 (3) 4 def = G def = G def = G ... D1 D2 D3 G (3) 4 ... ... def def = RD(G = RD(G = RD(G ... def (1) 1 , G (2) 2 , G (3) 3 , G (1) 2 ) (2) 3 ) (3) 4 ) Table 1: Each row depicts the growth sequence that leads to the construction of Gn+1 Dn is always de(cid:27)ned with respect to the subgraph G of Gn+1. (n) n+1. The distance (n) n on the vertices 1, . . . , n that led to the construction def = G The actual sequence of graphs {Gn} is created using this elementary process with a twist: for each index n, the graph Gn+1 is created by iterating the elementary growth process, starting with a single vertex and no edges, n + 1 times with the (cid:27)xed probabilities of connections pn and qn. Once Gn+1 is created, the growth is stopped, the probabilities of connections are updated and become pn+1 and qn+1. A new sequence of graphs is initialized to create Gn+2. Table 1 illustrates the di(cid:29)erent sequences of growth, of increasing lengths, that lead to the creation of G1, G2, . . .. This growth process guarantees that Gn+1 is always a subgraph of Gn, and that both Gn and Gn+1 have been created with the same probabilities. Furthermore, each Gn is distributed according to De(cid:27)nition 7, and the Gn are independent of one another. In order to study the dynamic evolution of the graph sequence, we focus on changes between two succes- (n) sive time steps n and n + 1. These changes are formulated in the form of the distance Dn = RD(G n , Gn+1) (n) n on the vertices 1, . . . , n, which led to the construction of Gn+1. The between Gn+1 and the subgraph G subgraph G is the graph on the left of the boxed graph Gn+1 on each row of Table 1. The de(cid:27)nition of Dn is the only potential caveat of the model: Dn is not the distance between Gn and Gn+1; this restriction is necessary since in general Gn is not a subgraph of Gn+1. (n) n This model provides a realistic prototype for the separation of scales present in the dynamics of large social network. Speci(cid:27)cally, the time index n corresponds to the slow dynamics associated with the evolution of the networks over long time scale (months to years). In contrast, the random realizations on each row of Table 1 embody the fast random (cid:30)uctuations of the network over short time scales (minutes to hours). In this work, we are interested in examining (cid:30)uctuations over fast time scales (minutes to hours). We expect that the probabilities of connection, (pn, qn) remain the same when we study the distance between Gn and Gn+1. As n increases, the connectivity patterns of members of the network evolve, and we change accordingly the probabilities of connection, (pn, qn). Similar dynamic stochastic block models have been proposed in the recent years (e.g., [19, 40, 48, 52, 53, 55, 54, 56], and references therein). In the stochastic blockmodel, each vertex u belongs to a community within the graph. If vertex u forms no cross-community edges, then the geometry of the graph is structurally the same. However, if u forms at least one cross-community edge, then (depending on the geometry of the preceding graphs in the sequence) the geometry may change signi(cid:27)cantly. We examine in what regimes of pn and qn we can di(cid:29)erentiate between the two situations with high probability. We phrase the result in terms of a hypothesis test, with the null hypothesis being that no cross-community edges have been formed in step n + 1. 9 Figure 5.1: A typical time series of Dn for a growing stochastic blockmodel. The red curve is the distance between time steps Dn and the blue vertical lines mark the formation of cross-community connections. Two di(cid:29)erent regimes are compared. On the left, the formation of cross-community edges is easily discernible, while on the right, such an event is quickly lost in the noise. Figure 5.1 shows a time series of distances Dn for a growing stochastic blockmodel. We see that when the in-community connectivity is much greater than the cross community connectivity, the formation of cross-community edges is easily discernible (left (cid:27)gure). However, when the level of connectivity is insu(cid:28)ciently separated, then the formation of cross-community edges is quickly lost in the noise. Our result clari(cid:27)es exactly what is meant when we say that the parameters pn and qn are "well separated." Our main result is given by the following theorem. Theorem 1. Let Gn+1 ∼ (cid:71)(n + 1, pn, qn) be a stochastic blockmodel with pn = ω (log n/n) , qn = ω(cid:0)1/n 2(cid:1), n(cid:1). Let Gn be the subgraph induced by the vertex set [n], with mn edges. Let qn = (cid:111) (pn/n), and pn = (cid:79)(cid:0)1/√ Dn = RD(Gn, Gn+1) be the normalized e(cid:29)ective resistance distance, RD, de(cid:27)ned in (3.3). To test the hypothesis H0 : kn = kn+1 versus H1 : we use the test based on the statistic Zn de(cid:27)ned by kn < kn+1 def= Zn 2 n 16m 4 n (Dn − n) , where we accept H0 if Zn < zε and accept H1 otherwise. The threshold zε for the rejection region satis(cid:27)es and ProbH0 (Zn ≥ zε) ≤ ε as n → ∞, ProbH1 (Zn ≥ zε) → 1 as n → ∞. The test has therefore asymptotic level ε and asymptotic power 1. Proof. The proof of the theorem can be found in Appendix C. 10 (5.3) (5.4) (5.5) (5.6) (5.7) (cid:3) Figure 5.2: Empirical distribution of Zn under the null hypothesis (solid line) and the alternate hypothesis (dashed line). The data is normalized so that the distribution has zero mean and unit variance under the n/n. The probability of null hypothesis. The probability of connection within each community is pn = log2 connection between C1 and C2 is qn = log n/n 3/2 (right). The box extends from the lower to upper quartile values of the data, with a line at the median. The whiskers extend from the box to show the full range of the data. Note that the y-axis is logarithmic in the left (cid:27)gure and linear in the right. 2 (left) and qn = log2 n/n Remark 6. In practice, it would be desirable to have an analytical expression for the constant zε such that we can compute a level ε test, Prob(Zn ≥ zε) ≤ ε under the null hypothesis. Unfortunately, our technique of proof, which is based on the asymptotic behavior of Zn does not yield such a constant. A more involved analysis, based on (cid:27)nite sample estimates of the distance, would be needed, and would yield an important extension of the present work. The results shown in Figure 5.2 suggest that one could numerically estimate a 1 − ε point wise con(cid:27)dence interval for Zn with a bootstrapping technique; the details of such a construction are the subject of ongoing investigation. 6 Experimental Analysis of Dynamic Community Networks Figure 5.2 shows numerical evidence supporting Theorem 1. The empirical distribution of Zn is computed under the null hypothesis (solid line) and the alternate hypothesis (dashed line). The data are scaled so that the empirical distribution of Zn under H0 has zero mean and unit variance. In the left and right (cid:27)gures, the density of edges remains the same within each community, pn = log2 The plot on the left of Fig. 5.2 illustrates a case where the density of cross-community edges remains su(cid:28)ciently low -- qn = log n/n 2 -- and the test statistic can detect the creation of novel cross-community edges (alternate hypothesis) without the knowledge of kn, or the identi(cid:27)cation of the communities. 3/2 -- for the statistic to be able to detect the creation of novel cross-community edges. In that case the hypotheses of Theorem 1 are no longer satis(cid:27)ed. In addition to the separation of the distributions of Zn under H0 and H1 guaranteed by Theorem 1 when qn/pn = (cid:111) (1/n), we start observing a separation between the two distributions when qn/pn = Θ(1/n) (not shown) suggesting that the hypotheses of Theorem 1 are probably optimal. In the regime where qn = ω (pn/n), shown in Fig. 5.2-right, the two distributions overlap. On the right, the density of cross-community edges is too large -- qn = log2 n/n. n/n 11 statistic Zn 7 Discussion At (cid:27)rst glance, our result may seem restrictive compared to existing results regarding community detection in the stochastic blockmodel. However, such a comparison is ill-advised, as we do not propose this scheme as a method for community detection. For example, Abbe et al. have shown that communities can be recovered ab > 1 [1]. Their method uses an algorithm that is designed speci(cid:27)cally for the purpose of community detection, whereas our work provides a very general tool, which can be applied on a broad range of dynamic graphs, albeit without the theoretical guarantees that we derive for the dynamic stochastic block model. asymptotically almost surely when pn = a log(n)/n and qn = b log(n)/n, provided that (a + b)/2 − √ Furthermore, the "e(cid:28)cient" algorithm proposed by Abbe et al. is only proven to be polynomial time, whereas resistance matrices can be computed in near-linear or quadratic time, for the approximate [44] and exact e(cid:29)ective resistance respectively. This allows our tool to be of immediate practical use, whereas results such as those found in [1] are of a more theoretical (cid:30)avor. Some argue against the use of the e(cid:29)ective resistance to analyze connectivity properties of a graph. In [51] it is shown that (cid:12)(cid:12)(cid:12)(cid:12)(cid:98)Ru v − 1 2 (cid:18) 1 du + 1 dv (cid:18) (cid:19)(cid:12)(cid:12)(cid:12)(cid:12) ≤ (cid:19) wmax 2 n δ 1 1 − λ2 + 2 , (7.1) and pn are ω(cid:0)1/n 2(cid:1), then such convergence will itself occur with high probability (see (C.14) for the relevant where λ2 is the second largest eigenvalue of the normalized graph Laplacian, dv is the degree of vertex v, δn is the minimum degree, and wmax is the maximum edge weight. If the right-hand side of (7.1) converges to 0, then the e(cid:29)ective resistance will converge to the average inverse degree of u and v. Luxburg et al. argue that the result (7.1) implies that when the bound converges to zero, the resistance will be uninformative, since it depends on local properties of the vertices and not global properties of the graph. Fortunately, this convergence can coexist peacefully alongside our result. In particular, if both expected degree and minimum degree approach in(cid:27)nity with high probability, as they will when both qn spectral gap bound). Since we only care about relative changes in resistance between Gn and Gn+1 in cases where cross-community edges are and are not formed, this is no problem for us. That said, the warning put forth by Luxburg et al. is well taken; we must be careful to make sure that we understand the expected behavior of the distance RD(Gn, Gn+1) and compare the observed behavior to this expected behavior rather than evaluate it on an absolute scale, since in many situations of interest this distance will converge to zero as the graph grows. Luxburg et al. have pointed out that the resistance can be (cid:27)ckle when used on graphs with high connectivity, which is to say a small spectral bound (1 − λ2)−1. We now know in which circumstances this will become an issue when looking at simple community structure. Further investigation is needed to know when other random graph models such as the small-world or preferential attachment model will be susceptible to analysis via the renormalized resistance metric. We are currently investigating the application of this analysis to a variety of real-world data sets. A Asymptotic Notations If {an}∞ n=1 and {bn}∞ n=1 are in(cid:27)nite sequences. The notations on the left have the interpretation on the right, an = (cid:79) (bn) an = (cid:111) (bn) an = ω (bn) an = Θ(bn) ∃n0 > 0,∃c > 0,∀n ≥ n0, ∀c > 0,∃n0 ≥ 0,∀n ≥ n0, ∀c > 0,∃n0 ≥ 0,∀n ≥ n0, ∃c1, c2 > 0,∃n0 ≥ 0,∀n ≥ n0, 0 ≤ an ≤ cbn, 0 ≤ an ≤ cbn, 0 ≤ cbn < an, 0 ≤ c1bn ≤ an ≤ c2bn. 12 We can adapt any of the above statements to doubly-indexed sequences an,k and bn,k by requiring that there exist an n0 ≥ 0 such that the conditions on the right hold for all n, k ≥ n0. B Notation Symbol Definition [n] (cid:71)(n, p) (cid:71)(n, p, q) Gn (cid:98)Ruv Ru v (n) R u v du dn kn (cid:69)[kn] mn RP(·, ·) RD(·, ·) The subset of natural numbers {1, . . . , n}. Erdős-Rényi random graph with parameters n and p stochastic blockmodel with parameters n, p, and q Subgraph of a graph G induced by the vertex set [n] E(cid:29)ective resistance between u and v Renormalized e(cid:29)ective resistance between u and v Renormalized e(cid:29)ective resistance between u and v in Gn Degree of vertex u (random variable) Mean degree (Erdős-Rényi) or expected in-community degree (stochastic blockmodel) Number of cross-community edges (random variable) Expectation of the number of cross-community edges Total number of edges Resistance-perturbation distance Renormalized resistance distance (with β = 1) Definition or Equation Number 5 7 1 (3.2) 6 & 8 8 (3.1) 4 C Proof of Main Result We begin by proving a lemma that allows us to transfer bounds on changes in e(cid:29)ective resistance into bounds on changes in renormalized resistances. Lemma 5. Suppose that(cid:98)R1 and(cid:98)R2 are two e(cid:29)ective resistances. If (cid:12)(cid:12)(cid:12) ≤ C2, then the corresponding renormalized resistances obey C1 ≤(cid:12)(cid:12)(cid:12)(cid:98)R1 −(cid:98)R2 ((cid:98)R1 + 1)((cid:98)R2 + 1) C1 Proof. Recall that the renormalized resistance corresponding to(cid:98)R is given by R = f ((cid:98)R) where f (x) = x/(x +1). ≤ R1 − R2 ≤ C2. (C.1) The mean value theorem thus implies that R1 − R1 ≤ sup x ∈(cid:82) f To obtain the lower bound, we compute: (cid:12)(cid:12)(cid:12) ≤(cid:12)(cid:12)(cid:12)(cid:98)R1 −(cid:98)R2 (cid:48)(x)(cid:12)(cid:12)(cid:12)(cid:98)R1 −(cid:98)R2 (cid:12)(cid:12)(cid:12)(cid:12)(cid:12) = (cid:98)R1 −(cid:98)R2 ((cid:98)R1 + 1)((cid:98)R2 + 1) (cid:12)(cid:12)(cid:12) ≤ C2. ((cid:98)R1 + 1)((cid:98)R2 + 1) . ≥ C1 (cid:12)(cid:12)(cid:12)(cid:12)(cid:12) (cid:98)R1(cid:98)R1 + 1 − (cid:98)R2(cid:98)R2 + 1 R1 − R1 = In our calculation above, we used the fact that(cid:98)R1 and(cid:98)R2 are non negative. (C.2) (cid:3) 13 C.1 Resistance Deviations in Erdős-Rényi We begin by analyzing the perturbations of the distance RD(Gn, Gn+1), de(cid:27)ned by (3.4), when Gn ∼ (cid:71)(n, pn) is an Erdős-Rényi random graph. Our ultimate goal is to understand a stochastic blockmodel, and we will leverage our subsequent understanding of the Erdős-Rényi model to help us in achieving this goal. Lemma 6. Let G ∼ (cid:71)(n, pn) be fully connected, with pn = ω (log n/n). For any two vertices u,v in G, we have Remark 7. The authors in [51] derive a slightly weaker bound, with high probability. + 1 dv (cid:19)(cid:12)(cid:12)(cid:12)(cid:12) = (cid:79) (cid:12)(cid:12)(cid:12)(cid:12)(cid:98)Ruv − (cid:18) 1 du (cid:32) 1 2 dn + 1 dv (cid:33) (cid:19)(cid:12)(cid:12)(cid:12)(cid:12) = (cid:111) (cid:18) 1 (cid:19) δn . (cid:12)(cid:12)(cid:12)(cid:12)(cid:98)Ruv − (cid:16)1/dn (cid:18) 1 du 2(cid:17) ; and thus we derive the bound (C.3) using one of the key results (Proposition We need the tighter factor (cid:79) 5) in [51]. Proof. De(cid:27)ne D to be the diagonal matrix with entries d1, . . . , dn. Since all degrees are positive (G is fully connected with high probability), we denote by D−1/2 the diagonal matrix with entries 1/√ d1, . . . , 1/√ explained above, we use Proposition 5 in [51] to bound the deviation of(cid:98)Ruv away from 1/du + 1/dv, dn. AD−1/2, with eigenvalues 1 = λ1 ≥ λ2 ≥ ... ≥ λn. As Let A be the adjacency matrix of G. De(cid:27)ne B = D−1/2 (cid:12)(cid:12)(cid:12)(cid:12)(cid:98)Ruv − (cid:18) 1 du + 2 + 1 1 − λ2 where δn is the minimum degree. De(cid:27)ne (C.3) (C.4) (C.5) (C.6) (C.7) (C.8) (C.9) We apply Cherno(cid:29)'s bound on the degree distribution, Now, and thus In the end, applying a union bound on all n vertices yields (cid:19) , . (cid:19) . (cid:18) 2 n δ 1 dv (cid:19)(cid:12)(cid:12)(cid:12)(cid:12) ≤ 2 (cid:113) (cid:12)(cid:12)(cid:12) ≥ εn εn = 6 log(n)dn . Prob(cid:16)(cid:12)(cid:12)(cid:12)dv − dn (cid:17) ≤ 2 exp (cid:18) 2 − ε n 3dn 2 ε n 3dn 6dn log n 2 , n = 2 . = log n 3dn (cid:12)(cid:12)(cid:12) ≥ εn Prob(cid:16)(cid:12)(cid:12)(cid:12)dv − dn (cid:17) ≤ 2 (cid:12)(cid:12)(cid:12) ≥ εn (cid:12)(cid:12)(cid:12)dv − dn (cid:17) ≤ 2 Prob(cid:16)∀v ∈ [n], (cid:12)(cid:12)(cid:12)(cid:12)(cid:12) = (cid:12)(cid:12)(cid:12)(cid:12)(cid:12) 1 (cid:12)(cid:12)(cid:12) . (cid:12)(cid:12)(cid:12)dn − dv − 1 2 d 3 2 v d n 2 dn 14 We consider dv in the interval [dn−εn, dn +εn]. The mean value theorem implies that there exists d ∈ (dn, dv), or d ∈ (dv , dn), such that Now, (cid:12)(cid:12)(cid:12)dn − d (cid:12)(cid:12)(cid:12) ≤ 2 d 3 2εn (dn − εn)3 = 2εn 3 dn (cid:16)1 − εn/dn 1 (cid:17)3 . At last, we use the following elementary fact 1 to conclude that ∀v ∈ [n], (cid:12)(cid:12)(cid:12)(cid:12)(cid:12) 1 d 2 v − 1 dn 2 (1 − x)3 ≤ 1 + 12x, (cid:19) (cid:18) 1 + 12 εn dn 0 ≤ (cid:12)(cid:12)(cid:12)(cid:12)(cid:12) ≤ 2εn (cid:18) dn 3 (cid:19) if x < 1/4, with probability greater than 2/n. This eventually yields an upper bound on the inverse of the minimum degree squared, 1 2 δ n ≤ 1 dn 2 + 2εn 3 dn 1 + 12 εn dn with probability greater than 2/n. To complete the proof of the lemma, we use a lower bound on the spectral gap 1− λ2. Because the density of edges is only growing faster than log n/n, we use the optimal bounds given by [9]. Applied to the eigenvalue λ2 of B, Theorem 1.2 of [9] implies that Theorem 2 ([9]). If dn > c log n/n, then with high probability, (C.10) (C.11) (C.12) (C.13) (C.14) (C.15) (C.16) The lower bound in (C.14) yields the following upper bound, with high probability, Using the bounds given by (C.13) with (C.15), which happen both with high probability, in (C.5) yields the advertised result. (cid:3) An important corollary of lemma 6 is the concentration of(cid:98)Ruv around 2/dn (see also [51] for similar results), Corollary 1. Let G ∼ (cid:71)(n, pn) be fully connected, with pn = ω (log n/n). With high probability, The lemma provides a con(cid:27)dence interval for the e(cid:29)ective resistance(cid:98)Ruv centered at d−1 v , for pairs of vertices present in the graph G at time n. We now use this result to bound the change in (renormalized) resistance between a pair of vertices u and v present in Gn, when the graph grows from Gn to Gn+1. u + d−1 1 − c(cid:113) dn . dn ≤ 1 − λ2 ≤ 1 + c(cid:113) ≤ 1 + c(cid:113) . dn 1 1 − λ2 (cid:12)(cid:12)(cid:12)(cid:12)(cid:98)Ruv − 2 dn (cid:12)(cid:12)(cid:12)(cid:12) = 16 dn (cid:33) (cid:32) 1 dn 2 + (cid:111) 2 . 15 Theorem 3. Let Gn+1 ∼ (cid:71)(n + 1, pn) be an Erdős-Rényi random graph with pn = ω (log n/n). Let Gn be the subgraph induced by the vertices [n] in Gn+1, and let dn = (n − 1)pn be the expected degree in Gn. Remark 8. It is important to note that the bound on changes in Ru v from time n to n + 1 only holds for the nodes u, v ∈ [n] that are already present in (cid:71)(n, pn). Indeed, for the new node n + 1 that is added at time n + 1, Proof. By Lemma 5, it su(cid:28)ces to prove the inequality with respect to the e(cid:29)ective resistance, rather than the renormalized resistance. . Using the triangle inequality, (cid:32) 1 (cid:33) 2 dn max u <v ≤n (n+1) u v − R (n) u v with high probability. (cid:12)(cid:12)(cid:12) = (cid:79) for any vertex u ∈ [n]. (n) u n+1 − R (n+1) u n+1 = 1 − R (n+1) u n+1 ≤ 1 we have(cid:98)R (n) u n+1 = ∞, and thus R (n) u n+1 (n+1) u n+1 − R The change in renormalized e(cid:29)ective resistance, when the graph Gn becomes Gn+1, is given by (n) u n+1 = 1. In this case, the bound in (C.17) is replaced by (cid:12)(cid:12)(cid:12)R (cid:12)(cid:12)(cid:12)(cid:98)R u v −(cid:98)R (cid:12)(cid:12)(cid:12)R (cid:12)(cid:12)(cid:12) = R (cid:12)(cid:12)(cid:12)(cid:12)(cid:12)(cid:98)R (cid:12)(cid:12)(cid:12) ≤ From lemma 6, we obtain bounds on the (cid:27)rst and third terms, of order (cid:79)(cid:0)1/δ the middle term is of order (cid:79)(cid:0)1/δ (cid:33)(cid:12)(cid:12)(cid:12)(cid:12)(cid:12) (cid:12)(cid:12)(cid:12)(cid:12)(cid:12)(cid:98)R (cid:1). Since d (cid:16)1/dn (cid:1), which can in turn be bounded by a term of order (cid:79) (cid:12)(cid:12)(cid:12)(cid:98)R u v −(cid:98)R (n) u denote the degree of vertex u in Gn, and similarly de(cid:27)ne d + (cid:33)(cid:12)(cid:12)(cid:12)(cid:12)(cid:12) . (cid:33) (cid:32) 1 probability using C.13. Putting everything together, we get d 1 (n) v 1 (n+1) u (cid:12)(cid:12)(cid:12) = (cid:79) (n) d u (n+1) u v − (cid:33)(cid:12)(cid:12)(cid:12)(cid:12)(cid:12) + 1 (n+1) u d (cid:12)(cid:12)(cid:12)(cid:12)(cid:12) (cid:32) 1 (n) d u 1 (n+1) v + 1 (n+1) v d (cid:32) 1 (cid:33) (n+1) u (cid:32) − 1 (n) v d (n) u v − Let d + d + (cid:32) d + 2 n (n+1) (n) u v (n+1) (n) u v 2 n (C.17) (C.18) (C.19) (n+1) u 2(cid:17) with high (n) u ≤ 1, − d 2 . dn The inequality is proven for the e(cid:29)ective resistance, and using lemma 5 it also holds for the renormalized resistance. (cid:3) C.2 E(cid:29)ective resistances in the stochastic blockmodel We (cid:27)rst recall that the number of cross-community edges, kn, is a binomial distribution, and thus concentrates around its expectation (cid:69)[kn] for large n, as explained in the following lemma. Lemma 7. Let Gn ∼ (cid:71)(n, pn, qn) be a (balanced two-community) stochastic blockmodel with pn = ω (log n/n) 2(cid:1). There exists n0, such that and qn = ω(cid:0)1/n ∀n ≥ n0, 3 4 < (cid:69)[kn] kn 3 2 , with probability > 0.9. < (C.20) Proof. The random variable kn is binomial B(n1n2, qn), where n1 = (cid:98)(n + 1)/2(cid:99), and n2 = (cid:98)n/2(cid:99). We have (cid:69)[kn] = n1n2qn. We apply a Cherno(cid:29)'s bound on kn to get Prob(kn − (cid:69)[kn] > ε) < 2e −ε2/(3(cid:69)[kn]) . (C.21) 16 Using ε = 3(cid:112) (cid:69)[kn], we get (cid:69)[kn](cid:17) Prob(cid:16)kn − (cid:69)[kn] > 3(cid:112) 1(cid:112) 1(cid:112) 2(cid:1) = ω (1), and thus limn→∞ (cid:69)[kn] = ∞. Consequently ∃n0 such that Now, (cid:69)[kn] = qnn1n2 = qn(cid:79)(cid:0)n with probability > 0.9. (cid:69)[kn] < 1 + 3 (cid:69)[kn] < (cid:69)[kn] 1 − 3 < 0.1 < 2e or −3 kn ∀n ≥ n0, (cid:69)[kn] > 81, (C.22) (C.23) (C.24) (C.25) (C.26) and thus ∀n ≥ n0, 3 4 < (cid:69)[kn] kn 3 2 , with probability > 0.9. < (cid:3) We now translate our understanding of the Erdős-Rényi random graph to the analysis of the stochastic blockmodel. As explained in lemma 4, in the following we write 1/dn when either 1/dn1 or 1/dn2 could be used, and the error between the two terms is no larger than (cid:79) Lemma 8 (Cross-community resistance bounds). Let Gn ∼ (cid:71)(n, pn, qn) be a (balanced two-community) stochastic blockmodel with pn = ω (log n/n) and qn = ω(cid:0)1/n cross-community edges. With high probability, the e(cid:29)ective resistance(cid:98)Ruv is bounded according to (cid:16)1/dn 2(cid:1). Let u and v be vertices in the communities (cid:32) 1 C1 and C2 respectively. Let dn be the expected in-community degree of C1. Let kn be the (random) number of 2(cid:17). (cid:33) ≤(cid:98)Ru v ≤ 1 kn 1 kn + 4 dn + (cid:79) . 2 dn (cid:16) (cid:17) the lower bound on(cid:98)Ruv we use the Nash-Williams inequality [36], which we brie(cid:30)y recall here. Let u and Remark 9. We recall (see lemma 4) that when we write dn, in C.32, it either means the expected degree of C1 or C2. Remark 10. The requirement that pn = ω(log(n)/n) guarantees that we are in a regime where resistances in the Erdős-Rényi graph converge to 2/dn. The requirement that qn = ω(1/n 2) guarantees that (cid:69)[kn] → ∞, and because of lemma 7, kn → ∞ with high probability. Finally, qn = o(pn/n) guarantees that (cid:69)[kn] = (cid:111) , dn and using lemma 7 we have kn = (cid:111) Proof of lemma 8. Without loss of generality, we assume that u ∈ C1, and v ∈ C2 (see Fig. C.1). To obtain v be two distinct vertices. A set of edges Ec is an edge-cutset separating u and u if every path from u to v includes an edge in Ec. Lemma 9 (Nash-Williams, [36]). If u and v are separated by K disjoint edge-cutsets Ek , k = 1, . . . , K, then with high probability. (cid:16) (cid:17) dn K k =1   (vn,vm)∈Ek −1 ≤(cid:98)Ruv , −1 n,m R  where (vn, vm) is an edge in the cutset Ek . (C.27) 17 (k +1) n of size n with kn cross-community edges. Figure C.1: Balanced, two community stochastic blockmodel G The vertices u and v are in di(cid:29)erent communities, u ∈ C1 and v ∈ C2. Since the set of cross-community edges is a cutset for all pairs of vertices u and v in separate communities, and since the size of this set is precisely kn, we immediately obtain the desired lower bound. The upper bound is obtained using the characterization of the e(cid:29)ective resistance based on Thomson principle [33], which we recall brie(cid:30)y in the following. Let f be a (cid:30)ow along the edges E from u to v, and let (C.28) (cid:69)(f ) = 2(e)Re , f e∈E be the energy of the (cid:30)ow f , where each undirected edge e in the sum is only counted once. A unit (cid:30)ow has strength one, Thomson's principle provides the following characterization of the e(cid:29)ective resistance(cid:98)Ru w, energy (cid:69)(f ) yields an upper bound on(cid:98)Ru w. (C.30) We use Thomson's principle in the following way: we construct a unit (cid:30)ow f from u to v. For this (cid:30)ow, the (cid:98)Ruv = min {(cid:69)(f ), f is a unit (cid:30)ow from u to v} . div(f )(u) = − div(f )(v) = 1. (C.29) First, consider the case where neither u nor v are incident with any of the kn cross-community edges, ei = (ui , vi), i = 1, . . . , kn; where ui ∈ C1 and vi ∈ C2. Denote by f u the unit (cid:30)ow associated with the to be e(cid:29)ective resistance between u and ui when only the edges in C1 are considered. Similarly de(cid:27)ne f v i the unit (cid:30)ow associated with the e(cid:29)ective resistance between v and vi when when only the edges in C2 are considered. Using the corollary 1, given by (C.16), we have with high probability, i 2 (cid:69)(f u i ) = and (cid:69)(f v i ) = 2 + (cid:79) dn We note that the expression of (cid:69)(f v i ) should involve the expected degree in C2. As explained in lemma 4, we can use dn since the di(cid:29)erence between the two terms is absorbed in the (cid:79) be the (cid:30)ow that is 1 on edge ei and 0 elsewhere. To conclude, we assemble the three (cid:30)ows and de(cid:27)ne term. Finally, let f e i + (cid:79) (cid:19) dn dn dn 2 . , 2 (C.31) (cid:32) 1 (cid:33) (cid:18) 1 dn 2 (cid:32) 1 (cid:33) which is a unit (cid:30)ow from u to v. Since (cid:69) is a convex function, we can bound the energy of f via (cid:8)f u (cid:32) 1 k k kn i =1 (cid:69)(f ) = (cid:69) ≤ 1 kn i (e) + f e i =1 (cid:69)(f u i ) + 1 kn + k i (e) + f v 1 kn i =1 (cid:69)(f v i ) = f (e) = i (e) + f e i (e) + f v i (e)(cid:9) , (cid:32) 1 + (cid:69) k kn i =1 k i =1 (cid:33) (cid:32) 1 i (e) f u (cid:33) + (cid:79) . 2 dn 1 kn k i (e)(cid:9)(cid:33) i =1 (cid:8)f u (cid:32) 1 ≤ (cid:69) 4 dn kn 1 kn + 18 (cid:33) (cid:32) 1 k (cid:33) i (e) f v kn i =1 i (e) f e + (cid:69) v1uunkvnku2C1C1v The (cid:27)nal line holds with high probability. Note that we calculate the energy of the (cid:30)ow in the center term directly, whereas convexity is used to estimate the energy in the (cid:27)rst and third term. This upper bound also holds when either u or v is incident with any of the cross-community edges. In between u and ui to be the zero this case, u = ui for some i. For this i, we can formally de(cid:27)ne the (cid:30)ow f u i (cid:30)ow, which minimizes the energy trivially and has energy equal to the resistance between u and ui (which is zero). Then the above calculation yields a smaller upper bound for the (cid:27)rst and third terms. (cid:3) Remark 11. Lemma 8 provides a (cid:27)rst attempt at analysing the perturbation of the e(cid:29)ective resistance under the addition of edges in the stochastic blockmodel. The upper bound provided by (C.26) is too loose to be useful, and we therefore resort to a di(cid:29)erent technique to get a tighter bound. The idea is to observe that the e(cid:29)ective resistance is controlled by the bottleneck formed by the cross-community edges. We can get very tight estimates of the (cid:30)uctuations in the e(cid:29)ective resistance using a detailed analysis of the addition of a single cross-community edge. We use the Sherman -- Morrison -- Woodburry theorem [15] to compute a rank-one perturbation of the pseudo-inverse of the normalized graph Laplacian [38], L†. The authors in [42] provide us with the exact expression that is needed for our work, see (C.36). The proof proceeds by induction on the number of cross-community edges, kn. Theorem 4. Let Gn ∼ (cid:71)(n, pn, qn) be a balanced, two community stochastic blockmodel with pn = ω(log n/n), qn = ω(1/n 2), and qn = o(pn/n). We assume that Gn is connected. The e(cid:29)ective resistance between two vertices u and v is given by (cid:98)Ru v = 2 dn +  (cid:79) 1 kn (cid:32) 1 (cid:33) + α(kn, u, v) dn 2 , dnkn (cid:32) 1 dn + (cid:79) (cid:33) if u and v are in the same community, (C.32) 2 , otherwise. Also, conditioned on kn = k the random variable α(kn, u, v) is a deterministic function of k, and we have α(kn, u, v) = (cid:79) (kn). Proof. First, observe that Lemma 8 immediately implies that −2kn ≤ α(kn, u, v) ≤ 2kn, ∀u, v, (C.33) with high probability, so α = (cid:79)(kn). Next, let us show that the in-community resistances follow the prescribed form. The proof proceeds as follows: we derive the expression (C.32) conditioned on the random variable kn = k, and we prove that α(k, u, v) is indeed a deterministic function in this case; the derivation of (C.32) is obtained by induction on k. The engine of our induction is the update formula (equation 11) in [42]. This provides an exact formula (equation (C.36) below) for the change in resistance between any pair of vertices in a graph when a single edge is added or removed. The particular motivation of the authors in [42] is to calculate rank one updates to the pseudoinverse of the combinatorial graph Laplacian; however, it conspires that their formula is also very useful to inductively calculate resistances in the stochastic blockmodel. We (cid:27)rst consider the base case, where Gn is a balanced, two community stochastic blockmodel of size n with kn = 1 cross-community edge. Denote this edge by e1 = (u1, v1), where u1 ∈ C1 and v1 ∈ C2. We will refer to this graph as G The addition of a single edge connecting otherwise disconnected components does not change the resistance within those components, as it does not introduce any new paths between two vertices within the same component. Because each community is an Erdős-Rényi graph with parameters pn and respective sizes (1) n . 19 n1 = (cid:98)(n + 1)/2(cid:99) and n2 = (cid:98)n/2(cid:99), corollary 1 provides the expression for the e(cid:29)ective resistance between two vertices within each community. A simple circuit argument allows us to obtain the resistance between u and v in separate communities via (cid:98)Ru v =(cid:98)Ru u1 +(cid:98)Ru1,v1 +(cid:98)Rv1,v . (cid:33) (cid:32) 1 If u (cid:44) u1 and v (cid:44) v1, then we combine Nash-Williams and corollary 1 to get 4 (cid:98)Ru v = 1 k + + (cid:79) dn . 2 dn If u = u1 and/or v = v1 then the appropriate resistances are set to zero in (C.34). In summary, for arbitrary pairs (u, v) in G (C.34) (C.35) (1) n , we have 1 k 2 + dn + α(u, v) kdn (cid:33) (cid:32) 1 dn + (cid:79) 2 , (cid:98)Ru v =  0 1 2 where α(u, v) = This establishes the base case for (C.32). if u = u1 and v = v1, if u = u1 and v (cid:44) v1, or u (cid:44) u1 and v = v1, if u (cid:44) u1 and v (cid:44) v1. We now assume that (C.32) holds for any balanced, two community stochastic blockmodel of size n with kn = k cross-community edges. We consider a balanced, two community stochastic blockmodel (k +1) of size n with kn = k + 1 cross-community edges. We denote the cross-community edges by G n ei = (ui , vi), i = 1, . . . , k + 1, where ui ∈ C1 and vi ∈ C2 (see Fig. C.2). (k +1) edges obtained by removing the edge ek +1 = (uk +1, vk +1) from G n (k) n the balanced, two community stochastic blockmodel with k cross-community Finally, we denote by G Let(cid:98)R denote the e(cid:29)ective resistances in G from(cid:98)R, (k) n is obtained by removing an edge from G Since G . (k) , we can apply equation (11) in [42] to express(cid:98)R(cid:48) n and(cid:98)R(cid:48) denote the e(cid:29)ective resistances in G (cid:104)((cid:98)Ru vk +1 −(cid:98)Ru uk +1) − ((cid:98)Rv vk +1 −(cid:98)Rv uk +1)(cid:105)2 (k +1) n (k +1) n . . (C.36) (cid:98)R u v =(cid:98)Ru v − (cid:48) 4(1 +(cid:98)Ruk +1 vk +1) Figure C.2: Balanced, two community stochastic blockmodel G edges. Vertices u and v are in the same community C1 (k +1) n of size n with kn = k +1 cross-community 20 v2C1Ck+1vk+1u1v1uu In the following we use the induction hypothesis to compute(cid:98)R(cid:48) using (C.36). We (cid:27)rst consider the case where the vertices u and v belong to the same community, say C1 without loss of generality (see Fig. C.2). We need to consider the following three possible scenarios: 1. u (cid:44) uk +1 and v (cid:44) vk +1, 2. u = uk +1 and v (cid:44) vk +1, 3. u (cid:44) uk +1 and v = vk +1. We will treat the (cid:27)rst case; the last two cases are in fact equivalent, and are straightforward consequences of the analysis done in the (cid:27)rst case. From the induction hypothesis we have Substituting these expression into (C.36), we get + α(k, u, vk +1) 2 (cid:33) (cid:98)R u v =(cid:98)Ru v − =(cid:98)Ru v − (cid:79) kdn 1 k 4(1 + + (cid:48) 2 dn 4 1 + + 1 k kdn Because α is bounded with high probability (see (C.33)), we have dn α(k, u, vk +1) − α(k, v, vk +1) k 2 1 k 1 + and also + α(k, uk +1 vk +1) (cid:16)1/dn which implies (cid:104) α(k, u, vk +1) − α(k, v, vk +1) + (cid:79) kdn dn + (cid:18) 4 1 + 1 k + 2 dn k + α(k, uk +1 vk +1) + (cid:79) + (cid:79) kdn + (cid:79) 2(cid:17) = (cid:79) (1) with high probability, 1 k + (cid:79) = 1 + (cid:17) with high probability, (cid:16)1/dn (cid:17)(cid:105)2 (cid:16)1/dn 2(cid:17)(cid:19) = (cid:79) (1) with high probability. (cid:16)1/dn 21 (cid:98)Ru vk +1 = (cid:98)Ru uk +1 = (cid:98)Rv vk +1 = (cid:98)Rv uk +1 = (cid:98)Ruk +1 vk +1 = (cid:20)(cid:18) 1 (cid:32) 1 k 2(cid:17) (cid:16)1/dn 2(cid:17) (cid:16)1/dn (cid:16)1/dn (cid:19) , , 2(cid:17) . + α(k, u, vk +1) kdn 2(cid:17) 2(cid:17) (cid:16)1/dn (cid:16)1/dn , , kdn + α(k, v, vk +1) + (cid:79) + (cid:79) 1 k 2 dn 1 k 2 dn 1 k + 2 dn + (cid:79) 2 dn + (cid:79) 2 dn + + + (cid:79) kdn + α(k, uk +1 vk +1) (cid:18) 1 (cid:19) − + α(k, uk +1 vk +1) kdn k + α(k, v, vk +1) + (cid:79) dn (cid:104) α(k, u, vk +1) − α(k, v, vk +1) (cid:18) kdn k 2 + α(k, uk +1 vk +1) (cid:17) (cid:16)1/dn 2(cid:17)(cid:21)2 + (cid:79) (cid:16)1/dn 2(cid:17)) (cid:16)1/dn (cid:16)1/dn (cid:17)(cid:105)2 2(cid:17)(cid:19) (cid:16)1/dn + (cid:79) + (cid:79) (C.37) (C.38) (C.39) (C.40) (C.41) (C.42) (C.43) (C.44) (C.45) (C.46) Figure C.3: Balanced, two community stochastic blockmodel G edges. The vertices u and v are in di(cid:29)erent communities, u ∈ C1 and v ∈ C2. (k +1) n of size n with kn = k +1 cross-community (cid:98)R u v =(cid:98)Ru v + (cid:79) (cid:48) (cid:16)1/dn 2(cid:17) with high probability. We conclude that (C.47) This completes the induction, and the proof of (C.32) in the case where u and v belong to the same community. We now consider the case where u ∈ C1 and v ∈ C2 (see Fig. C.3). As above, we need to consider the following three possible scenarios: 1. u (cid:44) uk +1 and v (cid:44) vk +1, 2. u = uk +1 and v (cid:44) vk +1, 3. u (cid:44) uk +1 and v = vk +1. Again, we only prove the (cid:27)rst case; the last two equivalent cases are straightforward consequences of the (cid:27)rst case. From the induction hypothesis we now have (cid:98)Ru uk +1 = (cid:98)Rv vk +1 = (cid:98)Ru vk +1 = (cid:98)Rv uk +1 = (cid:98)Ruk +1 vk +1 = 2 dn 2 dn 1 k 1 k 1 k + (cid:79) + (cid:79) 2 + + + dn 2 dn 2 dn 2(cid:17) 2(cid:17) (cid:16)1/dn (cid:16)1/dn , , kdn + α(k, u, vk +1) + α(k, v, vk +1) + α(k, uk +1 vk +1) kdn + (cid:79) + (cid:79) kdn (C.48) (C.49) (C.50) (C.51) (C.52) , , 2(cid:17) . 2(cid:17) (cid:16)1/dn 2(cid:17) (cid:16)1/dn (cid:16)1/dn + (cid:79) To reduce notational clutter, we use some abbreviated notation to denote the various α terms associated with the vertices of interest (see Fig. C.4), def def = α(k = α(k = α(k = α(k def def α0 α1 α2 α3 (k) n , u, v), (k) n , uk +1 v), (k) n , u, vk +1), (k) n , uk +1 vk +1). 22 v2C1Ck+1vk+1u1v1uu Figure C.4: Coe(cid:28)cients α0, . . . , α3 in (C.32) for several pairs of vertices in G (k +1) n . From (C.36), we have (cid:48) u v . def (cid:19) (cid:18) Let us denote the decrease in e(cid:29)ective resistance by ∆(cid:98)R, =(cid:98)Ru v −(cid:98)R ∆(cid:98)R 2(cid:17)(cid:21)2 (cid:19) (cid:16)1/dn 2(cid:17)(cid:19) (cid:16)1/dn 2(cid:17)(cid:21)2 (cid:16)1/dn 2(cid:17)(cid:33) (cid:16)1/dn (cid:20)(cid:18) 1 (cid:20) 1 + α1 + α2 2dn k + α3 kdn + α2 kdn 1 + ∆(cid:98)R = − α1 kdn −1 2 + (cid:79) + (cid:79) + (cid:79) + (cid:79) 1 + (cid:18) 1 k 1 k 1 2 − dn dn 4 2 4 = + + + = k 1 + α3 kdn k (cid:32) 1 (cid:18) 1 k = 2 + α1 + α2 2 dnk (α1 + α2)2 4(dnk)2 (cid:16)1/dn (cid:16)1/dn 2(cid:17) . 2(cid:17)(cid:17)−1 (cid:16)1/dn At this juncture, we need to expand(cid:16)1 + 1/k + 2/dn + α3/(kdn) + (cid:79) 2 + α1 + α2 2 dnk (cid:16)1/dn 1 + α3 kdn 1 + α3 kdn 2(cid:17)(cid:19) + (cid:79) + (cid:79) + (cid:79) 1 + 1 + 1 k 1 k dn dn 2 2 = + + k 2(cid:17) (cid:19) + (cid:79) 2(cid:17)(cid:21)2 (cid:16)1/dn 2(cid:17)(cid:19) (cid:16)1/dn + α3 kdn + (cid:79) (cid:18) (cid:20) 2 (cid:18) k 1 + 1 k 1 + α1 + α2 2dn 2 + dn (cid:16)1/dn 2(cid:17) + (cid:79) (C.53) (C.54) using a Taylor series, which is possible when 1/k + 2/dn + α3/(kdn) < 1. Since we are interested in the large n asymptotic, we can assume that for n su(cid:28)ciently large 2/dn + α3/(kdn) < 1/2, and thus we need to guarantee that k ≥ 2. The case k = 1 needs to be handled separately. Setting k = 1 into (C.54) yields for n su(cid:28)ciently large (2 + α3)/dn < 1, thus ∆(cid:98)R = (cid:18) (cid:16)1/dn 1 + α1 + α2 2 + α1 + α2 − 1 − α3/2 1 2 1 + (cid:79) dn 2dn 1 + α1 + α2 dn 2 + α3 dn 2 + + (cid:79) + (cid:79) 2(cid:17)(cid:19)(cid:18) (cid:16)1/dn 2(cid:17) 1 − 2 + α3 2dn , + (cid:79) ∆(cid:98)R = = (cid:16)1/dn 2(cid:17) (cid:16)1/dn 2(cid:17) , 1 2 (cid:16)1/dn 2(cid:17) (cid:16)1/dn 2(cid:17) = (cid:16)1/dn + (cid:79) 1 + α1 + α2 dn 2 + α3 2dn 1 + + (cid:79) + (cid:79) 2(cid:17)(cid:19) (cid:18) 1 2 = 1 + 2α1 + 2α2 − 2 − α3 2dn (C.55) 2(cid:17)(cid:19) (cid:16)1/dn + (cid:79) (C.56) 23 αααααv30210'vk+1uk+1u which matches the expression given in (C.32) for k = 2. This completes the induction for k = 1. We now proceed to the general case where k ≥ 2. In that case, we use a Taylor series expansion of 2 are obtained by choosing systematically 1/k in each of the m factors, or choosing 1/k in all but one factors and either 2 in the last factor. There are m ways to construct these last two terms. In summary, we have dn for m ≥ 1, or α3 kdn + α3 kdn + 2 dn k which leads to (cid:98)R u v =(cid:98)Ru v − ∆(cid:98)R = 1 + (cid:48) = 1 2 + 2 dn + Let 2 dn + α0 dn 2dn 2α0 − α1 − α2 + 1 + α3/2 2 dn 1 2 + (cid:48) u v = (cid:48) α 0 2dn , and we get then we have (cid:98)R (cid:16)1/dn (cid:16)1 + 1/k + 2/dn + α3/(kdn) + (cid:79) 2(cid:17)(cid:17)−1 (cid:16)1 + 1/k + 2/dn + α3/(kdn) + (cid:79) (cid:16)1/dn 2(cid:17)(cid:17)−1 ∞ Now, most of the term in(cid:16) 1 (cid:17)m are of order (cid:79) few signi(cid:27)cant terms. In the expansion of(cid:16) 1 (cid:19)m (cid:16)1/dn (cid:16)1 + 1/k + 2/dn + α3/(kdn) + (cid:79) We can substitute (C.61)into (C.60) to get 2(cid:17)(cid:17)−1 + α3 kdn ∞ α3 km−1 (cid:18) 1 + α3 kdn + 2 dn 1 km + m m=0 dn dn 2 = = + k k We can insert (C.62) into (C.54) to get ∆(cid:98)R = = (cid:18) 1 2 + α1 + α2 2 dnk 1 k(k + 1) + α1 + α2 dnk(k + 1) + (cid:79) k 24 . + (cid:79) 2dn 2 − α1 + α2 − 1 − α3/2 2(cid:17) (cid:16)1/dn − 1 2(cid:17) (cid:16)1/dn + (cid:79) + , 2(cid:17) (cid:16)1/dn , + (cid:79) (C.57) (C.58) (C.59) (cid:48) 0 α def = 2α0 − α1 − α2 + 1 + α3/2, (−1)m + 2 2(cid:17) (cid:19)m (cid:16)1/dn (cid:18) 1 (cid:16)1/dn 2(cid:17), and we need to carefully extract the (cid:17)m the only terms that do not contain a 1/dn + α3 kdn (C.60) + (cid:79) dn k . 2(cid:17) (cid:16)1/dn . + m 2 km−1 + (cid:79) dn ∞ α3 km−1 (k + 1)2 − 2 m=1 k m + (cid:79) + = = = k (−1)m 1 km m=0 1 − α3 1 + 1/k dn k + 1 − (α3 + 2k)k dn(k + 1)2 2(cid:17)(cid:19)(cid:32) (cid:16)1/dn k k + 1 − (α3 + 2k)k (cid:16)1/dn 2(cid:17) dn(k + 1)2 + (cid:79) − (α3 + 2k) dnk(k + 1)2 + (cid:79) 2(cid:17) dn (cid:16)1/dn + m 2 km−1 (k + 1)2 + (cid:79) dn k (cid:16)1/dn 2 2(cid:17) . 2(cid:17)(cid:33) (cid:16)1/dn + (cid:79) , (C.61) 2(cid:17) (cid:16)1/dn (C.62) (C.63) which leads to(cid:98)R u v =(cid:98)Ru v − ∆(cid:98)R (cid:48) = = Let then we have 2 + 1 k dn 1 k + 1 + − (cid:26) α0 + α0 dnk 2 + dn 1 dnk(k + 1) + k(k + 1) − α1 + α2 k + 1 k − α1 + α2 + α3 + 2k k(k + 1) k (α3 + 2k) dnk(k + 1)2 1 (cid:27) dn(k + 1) + (cid:79) + (cid:79) (cid:48) 0 = α0 + α0 − α1 − α2 def k + (cid:48) u v = 1 k + 1 + 2 + dn 2 k + 1 + (cid:48) 0 α k(k + 1) , α3 (cid:16)1/dn 2(cid:17) , dn(k + 1) + (cid:79) α (cid:98)R 2(cid:17) (cid:16)1/dn (cid:16)1/dn 2(cid:17) . (C.64) (C.65) (C.66) which matches the expression given in (C.32) for k + 1. This completes the induction and the proof of (C.32). 0 = α(k + 1, u, v) given by (C.65) is a deterministic function of k, since α0, α2, α2 and α3 all We note that α(cid:48) are deterministic functions of k, by the inductive hypothesis. The cases where u = uk +1 or v = vk +1 are treated similarly; since they present no new di(cid:28)culties they are omitted. This completes the proof of the theorem. (cid:3) Remark 12. As expected (C.65) agrees with the update formula in the case k = 1, given by (C.58). The update formula (C.65) implies that the random variables α(kn, u, v) and α(kn, u, v)/kn, both have bounded variation, as explained in the following corollary. Corollary 2. Let Gn+1 ∼ (cid:71)(n + 1, pn, qn) be a stochastic blockmodel with pn = ω (log n/n). Assume that qn = (cid:111) (pn/n). Let Gn be the subgraph of Gn+1 induced by the vertex set [n]. Let kn and kn+1 be the number of cross-community edges in Gn and Gn+1 respectively. Let u and v be two vertices, and let(cid:98)R Let α(kn, u, v) and α(kn+1, u, v) be the coe(cid:28)cients in the expansion of(cid:98)R u v and(cid:98)R (n+1) u v (n) respectively. u v and(cid:98)R (n) (n+1) u v be the e(cid:29)ective resistances measured in Gn and Gn+1 We have, α(kn+1, u, v) − α(kn, u, v) = (cid:79) (1) with high probability, (cid:12)(cid:12)(cid:12)(cid:12)α(kn+1, u, v) kn+1 (cid:12)(cid:12)(cid:12)(cid:12) = (cid:79) (cid:18) 1 (cid:19) kn − α(kn, u, v) kn with high probability. in (C.32) respectively. (C.67) (C.68) (C.69) (C.70) The proof of the corollary is a consequence of the following proposition which shows that, conditioned on kn = k, the functions α(k, u, v) and α(k, u, v)/k, de(cid:27)ned for k ≥ 1, have bounded variation. Proposition 1. Let Gn ∼ (cid:71)(n, pn, qn) be a balanced, two community stochastic blockmodel with pn = ω(log n/n), qn = ω(1/n 2), and qn = o(pn/n). We assume that Gn is connected. Let u and v be two ver- tices. Given kn = k, let α(k, u, v) be the coe(cid:28)cient in the expansion of(cid:98)Ru v in (C.32). Similarly, let α(k + 1, u, v) 25 be the corresponding quantity when kn = k + 1. We have α(k + 1, u, v) − α(k, u, v) ≤ 8, (cid:12)(cid:12)(cid:12)(cid:12)α(k + 1, u, v) k + 1 (cid:12)(cid:12)(cid:12)(cid:12) ≤ 6 k − α(k, u, v) k (C.71) (C.72) (C.73) . Proof. The proof is a direct consequence of (C.65), and the fact that α(k, u, v) ≤ 2k (see (C.33)). Let us start with the (cid:27)rst inequality. From (C.65) we have and thus α(k + 1, u, v) − α(k, u, v) = α(k, u, v) − α1 − α2 k + 2 k + 1 + α3 k(k + 1) , α(k + 1, u, v) − α(k, u, v) ≤ 6k + 2 k + 1 + 2k k(k + 1) = 6 + 4 k + 1 ≤ 8. k We now show the second inequality. Again, from (C.65) we have + α(k, u, v) − α1 − α2 + k(k + 1) 2 + (k + 1)2 + α3 k(k + 1)2 2 (k + 1)2 + k(k + 1)2 α3 α(k + 1, u, v) k + 1 − α(k, u, v) k and thus (cid:12)(cid:12)(cid:12)(cid:12)α(k + 1, u, v) k + 1 − α(k, u, v) k k = α(k, u, v) = −α(k, u, v) = − α1 + α2 k + 1 − α(k, u, v) k(k + 1) + α(k, u, v) − α1 − α2 k(k + 1)2 , k(k + 1) + (cid:12)(cid:12)(cid:12)(cid:12) ≤ k(k + 1) α3 (k + 1)2 + 4k 2 (cid:27) 2 2k k(k + 1)2 = ≤ 6 k + 1 ≤ 6 (k + 1)2 + 1 k + 1 k . k(k + 1) + ≤ 4 1 + k + 1 (cid:26) 4 k + 1 + 2 (k + 1)2 + 2 (k + 1)2 (C.74) (C.75) (C.76) (C.77) (cid:3) (C.78) (C.79) We now proceed to the proof of corollary 2. def Let ∆kn Proof of corollary 2. We (cid:27)rst verify that with high probability kn+1 − kn is bounded. We then apply proposi- tion 1. = kn+1 − kn be the number of adjacent cross-community edges that have vertex n + 1 as one of their endpoints. ∆kn is a binomial random variable B(n1, qn), where we assume without loss of generality that vertex n + 1 ∈ C2. Because (cid:69)[∆kn] = nqn/2 = pn(cid:111) (1), (cid:69)[∆kn] is bounded, and there exists κ such that ∀n, (cid:69)[∆kn] < κ. Using a Cherno(cid:29) bound we have Prob(cid:16)(cid:69)[∆kn] − ∆kn > 3√ (cid:17) ≤ 2 exp kn+1 − kn = kn+1 − (cid:69)[∆kn] + (cid:69)[∆kn] − kn < 6√ κ (cid:19) (cid:18) −1 3 < 0.01, κ with probability > 0.99 and thus 26 In other words, with high probability kn+1 − kn is bounded by C = (cid:100)6√ Finally, we have κ(cid:101), independently of n. (cid:12)(cid:12)(cid:12)(cid:12)α(kn+1, u, v) kn+1 − α(kn, u, v) kn (cid:12)(cid:12)(cid:12)(cid:12)α(kn+1, u, v) kn+1 − α(kn, u, v) kn (cid:12)(cid:12)(cid:12)(cid:12)(cid:12) (cid:12)(cid:12)(cid:12)(cid:12) − α(k, u, v) − α(k, u, v) k k k =kn k + 1 α(k + 1, u, v) (cid:12)(cid:12)(cid:12)(cid:12)(cid:12)kn+1−1 (cid:12)(cid:12)(cid:12)(cid:12) = (cid:12)(cid:12)(cid:12)(cid:12)α(k + 1, u, v) ≤ kn+1−1 (cid:12)(cid:12)(cid:12)(cid:12) ≤ C k + 1 6 kn k =kn Because of corollary 1, each term in the sum is bounded by 6/k; the largest upper bound being 6/kn. Also, with high probability there are at most C terms. We conclude that with high probability. (C.81) (cid:3) We now combine lemma 4 with theorem 4 to estimate the perturbation created by the addition of an n + 1th vertex to Gn. The following lemma shows that adding an additional vertex, with corresponding edges to either one of the communities does not change the e(cid:29)ective resistance, as long as no new cross-community edges are created. Lemma 10. Let Gn+1 ∼ (cid:71)(n + 1, pn, qn) be a stochastic blockmodel with pn = ω (log n/n). Assume that qn = (cid:111) (pn/n). Let Gn be the subgraph of Gn+1 induced by the vertex set [n]. Let kn and kn+1 be the number of cross-community edges in Gn and Gn+1 respectively. Let u and v be two vertices in Gn+1, for which the e(cid:29)ective resistance(cid:98)R Let(cid:98)R(n+1) be the corresponding e(cid:29)ective resistance measured in Gn+1. If u and v belong to the same community, then(cid:98)R(n+1) satis(cid:27)es (cid:33) (cid:32) 1 If u and v are in di(cid:29)erent communities, then(cid:98)R(n+1) is controlled by the following inequalities, (n+1) u v = (cid:79) ≥ 0. dn 2 (n) u v, measured in Gn, is properly de(cid:27)ned. (C.80) (C.82) (C.83) (C.84) (C.85) (n) (cid:98)R u v −(cid:98)R (cid:32) 1 (cid:33) (n+1) u v = (cid:79) ≥ 0, 2 dn + 1 dn (cid:79) u v ≥ 2 (n+1) 2 n k (n) (cid:98)R u v −(cid:98)R (cid:98)R u v −(cid:98)R (n)  Proof. Because of lemma 4, we have and 1 dn+1 = 1 dn+1 2 = 1 dn 1 dn if kn = kn+1, ≥ 0, if kn+1 > kn . (cid:19) kn (cid:18) 1 (cid:32) (cid:32) + (cid:79) 2 + (cid:79) 27 (cid:33) (cid:33) , 3 . 1 2 dn+1 1 dn+1 (n+1) u v (n) u v, given by (C.32) coincide, up to When u and v are in di(cid:29)erent communities, we need to consider the values of kn and kn+1. If kn = kn+1 (n+1) (n) (n) (n+1) u v (n) (n+1) u v (n+1) u v . order (cid:79) 2(cid:17). 2(cid:17). (n+1) u v (n+1) u v (n) u v, up to order (cid:79) (n) u v, given by (C.32) we have (cid:12)(cid:12)(cid:12) =(cid:98)R u v −(cid:98)R (n) and(cid:98)R (cid:16)1/dn (n+1) u v , since Gn+1 has more edges than Gn, and thus If u and v are in the same community, the expression for(cid:98)R (cid:16)1/dn then α(kn, u, v) = α(kn+1, u, v), and thus(cid:98)R u v =(cid:98)R If kn+1 > kn, we will show that the decrease in e(cid:29)ective resistance is of order Θ(cid:0)1/k that(cid:98)R u v ≥(cid:98)R (cid:12)(cid:12)(cid:12)(cid:98)R u v −(cid:98)R and(cid:98)R Using the expression for(cid:98)R (cid:12)(cid:12)(cid:12)(cid:98)R (cid:12)(cid:12)(cid:12) =(cid:98)R u v −(cid:98)R u v −(cid:98)R (n) − α(kn+1, u, v) + α(kn, u, v) − 1 kn+1 − α(kn+1, u, v) kn + 1 + α(kn, u, v) 1 (cid:18) α(kn, u, v) dn(kn + 1) + (cid:79) − α(kn+1, u, v) (cid:19) (cid:18) α(kn, u, v) kn + 1 − α(kn+1, u, v) kn + 1 (cid:12)(cid:12)(cid:12)(cid:12)α(kn + 1, u, v) (cid:18) 1 (cid:19) (cid:12)(cid:12)(cid:12)(cid:98)R u v −(cid:98)R 2 n We recall that corollary 2 implies that (cid:32) 1 (cid:33) (cid:32) 1 (cid:19) (cid:33) (cid:32) 1 + (cid:79) kn(kn + 1) + ≥ 1 2k (cid:12)(cid:12)(cid:12)(cid:12) = (cid:79) (cid:18) 1 − α(kn, u, v) (cid:33) (cid:32) 1 2 ≥ 1 kn and thus kn + 1 dn+1kn+1 = 1 kn 2 . dn (cid:12)(cid:12)(cid:12) ≥ 1 2k + (cid:79) 2 dn (n) (n+1) u v − 1 + kn 1 dn + 2 n (cid:79) , kn 1 dn kn (cid:19) 2 n k dnkn dnkn 1 dn ≥ kn dn 2 dn + (cid:79) n+1(cid:1). We (cid:27)rst recall 2 (cid:33) . (C.86) (C.87) (C.88) (C.89) (cid:3) which completes the proof. C.3 The Distance Dn Under the Null Hypothesis The following theorem provides an estimate of the distance Dn between Gn and Gn+1 after the addition of node n + 1. Under the null hypothesis -- n + 1 does not lead to an increase in the number of cross-community edges -- the change in the normalized e(cid:29)ective resistance distance between Gn and Gn+1 remains negligible (after removing the linear term H(n, kn)). Theorem 5. Let Gn+1 ∼ (cid:71)(n + 1, pn, qn) be a stochastic blockmodel with pn = ω (log n/n) , qn = ω(cid:0)1/n and qn = (cid:111) (pn/n). Let Gn be the subgraph induced by the vertex set [n], and let Dn = RD(Gn, Gn+1) be the normalized e(cid:29)ective resistance distance, RD, de(cid:27)ned in (3.3). 2(cid:1), 28 Suppose that the introduction of n + 1 does not create additional cross-community edges, that is kn = kn+1, then (C.90) (C.91) (cid:33) (cid:32) (cid:108)n 2 2 2 dn n (cid:109) Dn − h(n, kn) = (cid:79) ≥ 0, h(n, kn) = + kn 1 + kn . (cid:107) 2 (cid:106)n (cid:12)(cid:12)(cid:12) =  (cid:16)1/dn (cid:12)(cid:12)(cid:12)R u <v ≤n (n+1) u n+1 − R where Proof. Since vertex n + 1 is isolated in Gn, the change in resistance at vertex n + 1 between Gn and Gn+1 will behave quite di(cid:29)erently than as described in Theorem 3. For this reason, we separate the renormalized resistance distance into two portions: the pairs of nodes that do and do not contain vertex n + 1, Dn =  u <v ≤n+1 (n) u v (n+1) u v − R (cid:12)(cid:12)(cid:12)R u n+1 ≤(cid:98)R (n+1) u≤n (n) u v (cid:12)(cid:12)(cid:12) . (n) u n+1 (cid:12)(cid:12)(cid:12)R (n+1) u v − R (cid:12)(cid:12)(cid:12) + (cid:12)(cid:12)(cid:12)R 2(cid:17), and is therefore negligible. We can use the trivial (cid:12)(cid:12)(cid:12) ≤ 1. (n+1) u n+1 − R (n) u n+1 = 1. If u and n + 1 are in (n) u n+1 (C.92) Let us (cid:27)rst study the second sum. Because vertex n + 1 is isolated at time n, R the same community, then R (n+1) u n+1 ≥ 0 that yields bound R (n) u v = (cid:79) If u and n +1 are in di(cid:29)erent communities, then a tighter bound can be derived by considering the bottleneck formed by the cross-community edges. Indeed, a coarse application of Nash-Williams -- using only the cross-community cut-set -- tells us that the e(cid:29)ective resistance between vertices in di(cid:29)erent communities is greater than 1/kn, and thus the renormalized e(cid:29)ective resistance has the following lower bound, We now consider the (cid:27)rst sum in (C.92). Corollary 10 combined with lemma 5 yield which implies Observing that there are(cid:4) n2 nections, we have (cid:7) possible cross-community con- (n+1) u n+1 ≥ R 1 . . , + 2 2 u≤n (n) u n+1 (n) u n+1 1 + kn 1 + kn (cid:12)(cid:12)(cid:12)R (cid:12)(cid:12)(cid:12)R kn 1 + kn (n+1) u n+1 − R (n+1) u n+1 − R (cid:5) possible in-community connections and(cid:6) n2  (cid:33) (cid:32) 1 (cid:12)(cid:12)(cid:12)R (cid:33) (cid:12)(cid:12)(cid:12) ≤ kn (cid:12)(cid:12)(cid:12) ≤(cid:106)n (cid:109) (cid:108)n (cid:107) (cid:12)(cid:12)(cid:12) ≤(cid:12)(cid:12)(cid:12)(cid:98)R (cid:12)(cid:12)(cid:12) = (cid:79) u v −(cid:98)R (cid:32) (cid:12)(cid:12)(cid:12) = (cid:79) (cid:12)(cid:12)(cid:12)R  (cid:12)(cid:12)(cid:12) ≤(cid:106)n (cid:107) (n+1) u v − R (n+1) u v − R (cid:108)n u <v ≤n (n+1) (n) u v (n) u v (n) u v + (cid:79) (cid:32) (cid:109) 2 2 n 2 2 dn dn 2 + 2 kn 1 + kn n dn 2 , . (cid:33) = h(n, kn) + (cid:79) (C.93) (C.94) (C.95) (C.96) (cid:3) (cid:33) , (cid:32) n 2 2 dn which leads to the following bound on the (cid:27)rst sum, Combining (C.93) and (C.95) yields 0 ≤ Dn =  u <v ≤n+1 (cid:12)(cid:12)(cid:12)R (n+1) u v − R (n) u v which implies the advertised result. 29 The following corollary, which is an immediate consequence of the previous theorem provides the appropriate renormalization of Dn − h(n, kn) under the null hypothesis H0. Corollary 3. Let Gn+1 ∼ (cid:71)(n + 1, pn, qn) be a stochastic blockmodel with the same conditions on pn and qn as in Theorem 5, and let Gn be the subgraph induced by the vertex set [n]. Suppose that the introduction of n + 1 does not create additional cross-community edges, that is kn = kn+1, then (C.97) n (Dn − h(n, kn)) = (cid:79) (1) 0 ≤ p 2 Proof. As explained in lemma 4, we assume without loss of generality that n is even. We have then and thus which leads to n 2 2 = dn (cid:18) 1 (cid:19)(cid:19) n , (C.98) (C.99) (C.100) (n/2 − 1)2 2 = dn 2 n n(n/2 − 1)2 = 2 p (cid:18) n 2 2 p 2 = 4 n dn 1 + (cid:79) (Dn − h(n, kn)) = (cid:79) 2 n p 4 2 p n (cid:18) (cid:18) 1 (cid:32) n 1 + (cid:79) (cid:19)(cid:19) . (cid:33) n 2 2 dn , (C.101) (C.102) (cid:3) We recall that theorem 5 gives us the following bound on (Dn − h(n, kn)) under the null hypothesis, we conclude that 2 n (Dn − h(n, kn)) = (cid:79) (1) . p C.4 The Distance Dn Under the Alternate Hypothesis We now consider the case where the addition of node n + 1 leads to an increase in the number of cross- community edges. Loosening the bottleneck between the two communities creates a signi(cid:27)cant change in the normalized e(cid:29)ective resistance distance between Gn and Gn+1. Theorem 6. Let Gn+1 ∼ (cid:71)(n + 1, pn, qn) be a stochastic blockmodel with pn = ω (log n/n) , qn = ω(cid:0)1/n and qn = (cid:111) (pn/n). Let Gn be the subgraph induced by the vertex set [n], and let Dn = RD(Gn, Gn+1) be the normalized e(cid:29)ective resistance distance, RD, de(cid:27)ned in (3.3). 2(cid:1), Suppose that the introduction of n + 1 creates additional cross-community edges, that is kn+1 > kn, then ≤ Dn − h(n, kn), (C.103) 0 ≤ 1 16 where h(n, kn) is de(cid:27)ned in (C.91). (cid:26) n k 2 2 n 2 + n dn (cid:79) (cid:18) 1 (cid:19)(cid:27) kn 30 Proof. As before, we split the distance Dn into two terms, (n+1) u v − R (n+1) u v − R (n) u v Dn =  (cid:12)(cid:12)(cid:12)R u <v ≤n+1 (cid:12)(cid:12)(cid:12) =  (cid:12)(cid:12)(cid:12)R (cid:12)(cid:12)(cid:12) = 1 − R (n) u n+1 u <v ≤n (cid:12)(cid:12)(cid:12)R (n+1) u n+1 − R (n) u v 1≤i ≤n (cid:12)(cid:12)(cid:12) +  1 +(cid:98)R 1 (n+1) u n+1 Again, we analyze the second sum, which will generate the same linear contribution, (cid:12)(cid:12)(cid:12)R (n+1) u n+1 − R (n) u n+1 (cid:12)(cid:12)(cid:12) . (C.104) Because we seek an upper bound on R (n+1) have a more re(cid:27)ned analysis of R u n+1. In the case where u and n + 1 are in the same community, Theorem 4 tells us that (cid:12)(cid:12)(cid:12) we (n+1) u n+1 − R (n) u n+1 . (n+1) u n+1 = (n+1) u n+1 to obtain an lower bound on the change(cid:12)(cid:12)(cid:12)R (cid:98)R (cid:32) 1 (n+1) u n+1 = + (cid:79) (cid:33) 2 2 , dn+1 dn . . dn (cid:19) (cid:18) 1 (cid:19) (cid:18) 1 (cid:32) 1 (cid:19) (cid:18) 1 dn dn 2 dn . (cid:33) , We use the inequality 1 1+x ≥ 1 − x, which is valid for all x > −1, to get a lower bound, (n+1) u n+1 − R = 1 + (cid:79) (n) u n+1 + (cid:79) 2 1 (n+1) u n+1 ≥ 1 − 2 dn+1 We also use the inequality 1 1+x ≤ 1 − x/2, which is valid for all x ∈ [0, 1], to get an upper bound, (cid:12)(cid:12)(cid:12)R (cid:12)(cid:12)(cid:12)R (n+1) u n+1 − R (n) u n+1 (cid:12)(cid:12)(cid:12) = (cid:12)(cid:12)(cid:12) = 1 +(cid:98)R 1 +(cid:98)R (cid:32) 1 (cid:32) 1 dn (cid:33) (cid:33) If u and n + 1 are in separate communities, Lemma 8 tells us that 1 (n+1) u n+1 ≤ 1 − 1 dn+1 (cid:32) (cid:33) = 1 + (cid:79) + (cid:79) 2 dn 4 + dn+1 + (cid:79) 1 + kn Using again the inequality 1 and using the inequality 1 1 kn+1 (cid:12)(cid:12)(cid:12)R + 4 1 + (cid:79) kn+1 ≤(cid:98)R u n+1 ≤ 1 (n+1) 1+x ≥ 1 − x, we get a lower bound, (n) u n+1 dn+1 dn+1 + (cid:79) ≤ 1 2 (n+1) u n+1 − R 1 + kn dn 1+x ≤ 1 − x/2 we get an upper bound, 1 (cid:33) (cid:12)(cid:12)(cid:12) ≥ 1 − (cid:12)(cid:12)(cid:12)R − 4 dn+1 (cid:32) 1 (cid:12)(cid:12)(cid:12) ≤ 1 − 1 (cid:12)(cid:12)(cid:12)R ≤ 2kn+1 (n+1) u n+1 − R (n) u n+1 ≤ 1. (cid:107) (cid:109) (cid:108)n (cid:106)n Combining (C.105), (C.106),(C.108), and (C.109), we get (cid:12)(cid:12)(cid:12) ≤ n + (cid:79) We now consider the (cid:27)rst sum in (C.104). To get lower and upper bounds on(cid:12)(cid:12)(cid:12)(cid:98)R (n+1) u n+1 − R kn 1 + kn (n) u n+1 u≤n + (cid:79) dn 2 2 + (cid:18) n (cid:19) (cid:18) n (cid:19) u v −(cid:98)R dn (n+1) . (C.110) (cid:12)(cid:12)(cid:12) we use lemma 5. (n) u v 2 = kn 1 + kn + (cid:79) (C.105) (C.106) (C.107) (C.108) (C.109) 31 u v ≤ 1, and thus(cid:98)R ≤(cid:12)(cid:12)(cid:12)(cid:98)R u v −(cid:98)R u v)(1 +(cid:98)R C(u, v) (n) (n+1) u v ) (n+1) (cid:12)(cid:12)(cid:12) . (n) u v (n+1) u v ≤ 1. Combining this 4 ≤ (n) u v (n+1) (cid:12)(cid:12)(cid:12) (cid:18) 1 From corollary 10 we have (n) upper bound on the e(cid:29)ective resistance with lemma 5 we get We (cid:27)rst observe that for n su(cid:28)ciently large, we have(cid:98)R if C(u, v) ≤(cid:12)(cid:12)(cid:12)(cid:98)R u v −(cid:98)R (1 +(cid:98)R C(u, v) = (cid:79) (cid:12)(cid:12)(cid:12) ≥  (cid:19) (cid:18) 1 C(u, v) +  then C(u, v) (cid:19) C(u, v) ≥ 1 4 and therefore (n+1) u v − R (cid:12)(cid:12)(cid:12)R (n) u v dn 2 n k kn dn (cid:79) 2 1 + 2 C(u, v) ≥ n 4k 2 n u,v ∈di(cid:29)erent communities u,v ∈same community u <v ≤n if u and v are in the same community, otherwise, (cid:18) 1 (cid:19) kn + n 2 4 (cid:79) (cid:33) 2 , (cid:32) 1 dn 2 + n 4dn (cid:79) where the di(cid:29)erences between n/2 and the exact size of C1 or C2 are absorbed in the error terms. Also, we have (C.111) (C.112) (C.113) (C.114) (C.115) (C.116) (C.117) (C.118) (C.119) and thus Finally, we note that  u <v ≤n (cid:12)(cid:12)(cid:12)R (cid:19) (cid:18) 1 (cid:26) n kn 2 2 n k , 2 + n dn (cid:79) (cid:18) 1 (cid:19)(cid:27) kn . 1 dn 2 = 1 (cid:79) dn (cid:12)(cid:12)(cid:12) ≥ 1 16 (n+1) u v − R (n) u v 2 n = n dnkn kn n 2 = n dnkn kn n Because of lemma 7, we have asymptotically with high probability, 2 = n dnkn n dn (cid:79) and thus we conclude that = n dn Lastly, we add the two sums (C.110) and (C.115) to get (cid:107) (cid:106)n 2 (cid:109) (cid:108)n 2 + kn 1 + kn + 1 16 2 2 n k 2 + n dn (cid:79) (cid:19) (cid:19) dn n (cid:18) (cid:69)[kn] (cid:18) n (cid:26) n dn (cid:79) 2 = n dnkn 2 (cid:79) (nq) = n dn (cid:18) 1 (cid:19)(cid:27) kn . (cid:19) ≤  2 (cid:79) (cid:18) 1 kn u <v ≤n+1 (cid:18) 1 (cid:19) kn , (cid:79) (cid:12)(cid:12)(cid:12)R (n+1) u v − R (n) u v (cid:12)(cid:12)(cid:12) . The leading term linear term, h(n, kn), in (C.119) can be subtracted to arrive at the advertised result. Using the same normalization described in corollary 3 we obtain a very di(cid:29)erent growth for p in the case of the alternate hypothesis. (cid:3) n(Dn −h(n, kn)) 2 32 Corollary 4. Let Gn+1 ∼ (cid:71)(n + 1, pn, qn) be a stochastic blockmodel with the same conditions on pn and qn as in Theorem 5, and let Gn be the subgraph induced by the vertex set [n]. Suppose that the introduction of n + 1 creates additional cross-community edges, that is kn+1 > kn, then 0 ≤ pn (Dn − h(n, kn)) → ∞ with high probability. (C.120) Proof. As explained in lemma 4, we assume without loss of generality that n is even. From (C.103) we have (C.121) (C.122) 2 n Without loss of generality we assume n even, and we have k pn (Dn − h(n, kn)) ≥ 1 16 (cid:19) (cid:18) 1 (npn)2 = pn(n/2 − 1)qn(n kn (npn)2 dn (cid:79) (cid:26)(npn)2 (cid:18) 1 (cid:19)(cid:27) kn + (npn)2 dn (cid:79) 2/4) (cid:79) (1) = pn nqn (cid:79) (1) = ω (1) (cid:79) (1) . Therefore the second term in (C.121) is either bounded, or goes to in(cid:27)nity. We will prove that the (cid:27)rst term goes to in(cid:27)nity. We have . 2 = = = kn npn npn npn kn 4pn nqn qn(n/2)2 (cid:69)[kn] kn (cid:69)[kn] kn (cid:69)[kn] (cid:69)[kn] (C.123) From lemma 7 we know that asymptotically (cid:69)[kn]/kn = Θ(1) with high probability. Also, we have pn/(nqn) = ω (1). This concludes the proof. (cid:3) n(Dn − h(n, kn)) could provide a statistic to test the null hypothesis kn = kn+1 against n(Dn − h(n, kn)) requires the knowledge the alternate hypothesis kn < kn+1. Unfortunately, computing p of the unknown parameter pn, and unknown variable h(n, kn). We therefore propose two estimates that converge to these unknowns. A simple estimate of h(n, kn) is provided by n. Since we assume that there are much fewer cross-community edges than edges within each community, we can estimate pn from the total number of edges. The quantity p We start with two technical lemmas. The (cid:27)rst lemma shows that can replace h(n, kn) with n. Lemma 11. Let Gn ∼ (cid:71)(n, pn, qn) be a stochastic blockmodel with the same conditions on pn and qn as in 2 Theorem 5. If pn = (cid:79)(cid:0)1/√ n(cid:1), then we have lim n→∞ p Proof. We have Because (cid:100)n/2(cid:101) = (n/2)Θ(1), we have Now, we have kn/(kn + 1) < 1, np 2 n (n − h(n, kn)) = 0 with high probability. (cid:108)n (cid:109) 1 n − h(n, kn) = 2 kn + 1 . 2(cid:69)[kn] (cid:69)[kn] n = (cid:79) (1), and (cid:69)[kn] = ω (1), therefore 2(kn + 1) = kn np np 2 n 2 n 2 2 n(n − h(n, kn)) = Θ(1) p kn kn + 1 Θ(1) . Finally, we recall that (cid:69)[kn]/kn = Θ(1) with high probability, which concludes the proof. lim n→∞ 2 np n 2(cid:69)[kn] kn kn + 1 Θ(1) = 0. 33 (C.124) (C.125) (C.126) (C.127) (cid:3) We now consider the estimation of pn. Lemma 12. Let Gn ∼ (cid:71)(n, pn, qn) be a stochastic blockmodel with the same conditions on pn and qn as in Theorem 5. Let mn be the total number of edges in Gn. Then the probability pn can be estimated asymptotically from mn and n, 4mn 2 = pn (1 + (cid:79) (1/n)) , with high probability. n (C.128) Proof. The proof proceeds in two steps. We (cid:27)rst show that kn concentrates around its expectation (cid:69)[kn], and then we argue that limn→∞ 4(cid:69)[mn]/n The total number of edges, mn, in the graph Gn, can be decomposed as 2 = pn. (C.129) where mn1 (mn2) is the number of edges in community C1 (C2). The three random variables are binomial (with di(cid:29)erent parameters), and they concentrate around their respective expectations. Consequently mn also concentrates around its expectation, and we can combine three Cherno(cid:29) inequalities using a union bound to show that mn = mn1 + mn2 + kn, A quick computation of (cid:69)[mn] shows that Also, qn/pn = (cid:111) (1/n), and thus 2 (cid:69)[mn] = pn n 4 To conclude, we combine (C.130) and (C.132), to get mn (cid:18) (cid:69)[mn] = Θ(1) , with high probability. (cid:19)(cid:19) (cid:18) 1 (cid:19)(cid:19) 1 − 2 (cid:18) (cid:69)[mn] = pn 2 n 4 qn pn + (cid:111) + n n 2 . 1 + (cid:79) . (cid:18) 1 (cid:18) n (cid:18) 1 (cid:19)(cid:19) n , (C.130) (C.131) (C.132) (C.133) 4mn 2 = mn (cid:69)[mn] n which concludes the proof. 4(cid:69)[mn] 2 n = pn 1 − (cid:79) We de(cid:27)ne the following statistic that asymptotically converges toward p probability, as explained in the next theorem. De(cid:27)nition 9. Let Gn+1 ∼ (cid:71)(n, pn, qn) be a stochastic blockmodel with the same conditions on pn and qn as in Theorem 5. Let Gn be the subgraph induced by the vertex set [n]. Let Dn = RD(Gn, Gn+1) be the normalized e(cid:29)ective resistance distance, RD, de(cid:27)ned in (3.3). (cid:3) n(Dn − h(n.kn)) with high 2 We de(cid:27)ne the statistic (C.134) Theorem 7. Let Gn ∼ (cid:71)(n, pn, qn) be a stochastic blockmodel with the same conditions on pn and qn as in Zn def= Theorem 5. If pn = (cid:79)(cid:0)1/√ n(cid:1), then we have (Dn − n) . 2 n 16m 4 n Zn = p 2 n (Dn − h(n, kn))(1 + (cid:111) (1)) , with high probability. (C.135) 34 Proof. The proof is an elementary consequence of the two lemmas 11 and 12. We have 16m 2 n Using lemma 12, we have 2 n (Dn − n) = 2 n 16m 4 n (Dn − h(n, kn)) + 2 n 16m 4 n (h(n, kn) − n) . (C.136) 2 n 16m 2 n (Dn − n) = p 2 n (1 + (cid:79) (1/n))2 (Dn − h(n, kn)) + (1 + (cid:79) (1/n))2 2 n (h(n, kn) − n) . p (C.137) Lemma 11 shows that the second term can be neglected, 2 n 16m 2 n (Dn − n) = p = p n (1 + (cid:79) (1/n))(Dn − h(n, kn)) + (1 + (cid:79) (1/n)) (cid:111) (1) n (Dn − h(n, kn))(1 + (cid:79) (1/n)) + (cid:111) (1) . n (Dn − h(n, kn)) is either bounded, or goes to in(cid:27)nity, we have 2 2 2 Because p 2 2)(Dn − n) (16m n/n n (Dn − h(n, kn)) = 1 + (cid:111) (1) , 2 p which concludes the proof. We (cid:27)nally arrive at the main theorem. (C.138) (C.139) (cid:3) Theorem 8. Let Gn+1 ∼ (cid:71)(n, pn, qn) be a stochastic blockmodel with the same conditions on pn and qn as in Theorem 5. Let Gn be the subgraph induced by the vertex set [n]. To test the hypothesis versus H0 : H1 : kn = kn+1 kn < kn+1 (C.140) (C.141) we use the test based on the statistic Zn de(cid:27)ned in (C.134) where we accept H0 if Zn < zε and accept H1 otherwise. The threshold zε for the rejection region satis(cid:27)es ProbH0 (Zn ≥ zε) ≤ ε as n → ∞, (C.142) and ProbH1 (Zn ≥ zε) → 1 as n → ∞. The test has therefore asymptotic level ε and asymptotic power 1. Proof. Assume H0 to be true. Because of corollary 3 and Theorem 7, Zn = (cid:79) (1) , with high probability. In other words, for every 0 < ε < 1 there exists zε such that or Prob(Zn < zε) = 1 − ε, as n → ∞, Prob(Zn ≥ zε) = ε, as n → ∞. 35 (C.143) (C.144) (C.145) (C.146) Assume now H1 to be true. Because of corollary 4 and Theorem 7, Zn = ω (1) , with high probability Therefore, for every 0 < γ < 1, there exists n0 such that ∀n ≥ n0, Prob(Zn > zε) = 1 − γ , as n → ∞. In other words, which concludes the proof. ProbH1 (Zn ≥ zε) → 1 as n → ∞, (C.147) (C.148) (C.149) (cid:3) References [1] Emmanuel Abbe, Afonso S Bandeira, and Georgina Hall. "Exact recovery in the stochastic block model". In: IEEE Transactions on Information Theory 62.1 (2016), pp. 471 -- 487. [2] Richard M Adler. "A dynamic social network software platform for counter-terrorism decision support". In: Intelligence and Security Informatics, 2007 IEEE. IEEE. 2007, pp. 47 -- 54. Leman Akoglu, Hanghang Tong, and Danai Koutra. "Graph based anomaly detection and description: a survey". In: Data Mining and Knowledge Discovery 29.3 (2014), pp. 626 -- 688. [3] [4] Brian Baingana and Georgios B Giannakis. "Joint community and anomaly tracking in dynamic networks". In: IEEE Transactions on Signal Processing 64.8 (2016), pp. 2013 -- 2025. Juan I Fuxman Bass et al. "Using networks to measure similarity between genes: association index selection". In: Nature methods 10.12 (2013), pp. 1169 -- 1176. [5] [6] Michael Baur and Marc Benkert. "Network comparison". In: Network analysis. Springer, 2005, pp. 318 -- 340. [7] Béla Bollobás. Modern graph theory. Vol. 184. Springer, 2013. [8] Yun Chi, Xiaodan Song, Dengyong Zhou, Koji Hino, and Belle L Tseng. "Evolutionary spectral clustering by incorporating temporal smoothness". In: Proceedings of the 13th ACM SIGKDD international conference on Knowledge discovery and data mining. ACM. 2007, pp. 153 -- 162. [9] Amin Coja-Oghlan. "On the Laplacian eigenvalues of G(n, p)". In: Combinatorics, Probability and Computing 16.06 (2007), pp. 923 -- 946. P.G. Doyle and J.L. Snell. "Random walks and electric networks". In: AMC 10 (1984), p. 12. [10] [11] W. Ellens, F.M. Spieksma, P. Van Mieghem, A. Jamakovic, and R.E. Kooij. "E(cid:29)ective graph resistance". In: Linear Algebra and its Applications 435.10 (2011), pp. 2491 -- 2506. [12] Wenjie Fu, Le Song, and Eric P Xing. "Dynamic mixed membership blockmodel for evolving networks". In: Proceedings of the 26th annual international conference on machine learning. ACM. 2009, pp. 329 -- 336. [15] [14] [13] A. Ghosh, S. Boyd, and A. Saberi. "Minimizing E(cid:29)ective Resistance of a Graph". In: SIAM Rev. 50.1 (Feb. 2008), pp. 37 -- 66. Frédéric Gilbert, Paolo Simonetto, Faraz Zaidi, Fabien Jourdan, and Romain Bourqui. "Communities and hierarchical structures in dynamic social networks: analysis and visualization". In: Social Network Analysis and Mining 1.2 (2011), pp. 83 -- 95. Jonathan S Golan. The linear algebra a beginning graduate student ought to know. Springer Science & Business Media, 2012. Leonardo L Gollo and Michael Breakspear. "The frustrated brain: from dynamics on motifs to communities and networks". In: Philosophical Transactions of the Royal Society B: Biological Sciences 369.1653 (2014), p. 20130532. [17] Derek Greene, Donal Doyle, and Padraig Cunningham. "Tracking the evolution of communities in dynamic social networks". In: Advances in social networks analysis and mining (ASONAM), 2010 international conference on. IEEE. 2010, pp. 176 -- 183. [16] 36 [18] Creighton Heaukulani and Zoubin Ghahramani. "Dynamic probabilistic models for latent feature propagation in social networks". In: International Conference on Machine Learning. 2013, pp. 275 -- 283. [19] Qirong Ho, Le Song, and Eric P Xing. "Evolving Cluster Mixed-Membership Blockmodel for Time-Varying Networks". In: Journal of Machine Learning Research 15 (), pp. 342 -- 350. [20] N Hoque, Monowar H Bhuyan, Ram Charan Baishya, DK Bhattacharyya, and Jugal K Kalita. "Network attacks: Taxonomy, tools and systems". In: Journal of Network and Computer Applications 40 (2014), pp. 307 -- 324. [21] Marc-Thorsten Hütt, Marcus Kaiser, and Claus C Hilgetag. "Perspective: network-guided pattern formation of neural dynamics". In: Philosophical Transactions of the Royal Society B: Biological Sciences 369.1653 (2014), p. 20130522. [22] Tsuyoshi Ide and Hisashi Kashima. "Eigenspace-based anomaly detection in computer systems". In: Proceedings of the tenth ACM SIGKDD international conference on Knowledge discovery and data mining. ACM. 2004, pp. 440 -- 449. [23] Katsuhiko Ishiguro, Tomoharu Iwata, Naonori Ueda, and Joshua B Tenenbaum. "Dynamic in(cid:27)nite relational model for time-varying relational data analysis". In: Advances in Neural Information Processing Systems. 2010, pp. 919 -- 927. [24] Márton Karsai, Nicola Perra, and Alessandro Vespignani. "Time varying networks and the weakness of strong ties". In: Scienti(cid:27)c reports 4 (2014). [25] Alistair King, Bradley Hu(cid:29)aker, Alberto Dainotti, et al. "A coordinated view of the temporal evolution of large-scale internet events". In: Computing 96.1 (2014), pp. 53 -- 65. [26] D.J. Klein and M. Randić. "Resistance distance". In: Journal of Mathematical Chemistry 12.1 (1993), pp. 81 -- 95. [27] Mladen Kolar, Le Song, Amr Ahmed, and Eric P Xing. "Estimating time-varying networks". In: The Annals of Applied Statistics (2010), pp. 94 -- 123. [28] Danai Koutra, Neil Shah, Joshua T Vogelstein, Brian Gallagher, and Christos Faloutsos. "Delta Con: Principled Massive-Graph Similarity Function with Attribution". In: ACM Transactions on Knowledge Discovery from Data (TKDD) 10.3 (2016), p. 28. Lauri Kovanen, Márton Karsai, Kimmo Kaski, János Kertész, and Jari Saramäki. "Temporal Motifs". In: Temporal Networks. Springer, 2013, pp. 119 -- 133. [29] [30] Timothy La Fond, Jennifer Neville, and Brian Gallagher. "Anomaly Detection in Dynamic Networks of Varying Size". In: arXiv preprint arXiv:1411.3749 (2014). [31] Guillaume Laurent, Jari Saramäki, and Márton Karsai. "From calls to communities: a model for time-varying social networks". In: The European Physical Journal B 88.11 (2015), p. 301. [32] Hyekyoung Lee, Zhiwei Ma, Yuan Wang, and Moo K Chung. "Topological Distances between Networks and Its Application to Brain Imaging". In: arXiv preprint arXiv:1701.04171 (2017). [33] David Asher Levin, Yuval Peres, and Elizabeth Lee Wilmer. Markov chains and mixing times. American Mathe- matical Soc., 2009. [34] Yu-Ru Lin, Yun Chi, Shenghuo Zhu, Hari Sundaram, and Belle L Tseng. "Analyzing communities and their evolutions in dynamic social networks". In: ACM Transactions on Knowledge Discovery from Data (TKDD) 3.2 (2009), p. 8. [35] Yu-Ru Lin, Yun Chi, Shenghuo Zhu, Hari Sundaram, and Belle L Tseng. "Facetnet: a framework for analyzing communities and their evolutions in dynamic networks". In: Proceedings of the 17th international conference on World Wide Web. ACM. 2008, pp. 685 -- 694. [36] R. Lyons and Y. Peres. "Probability on Trees and Networks". In preparation. Available at http : / / http : //mypage.iu.edu/~rdlyons/http://mypage.iu.edu/ rdlyons. 2005. [37] Bivas Mitra, Lionel Tabourier, and Camille Roth. "Intrinsically dynamic network communities". In: Computer Networks 56.3 (2012), pp. 1041 -- 1053. [38] Nathan D Monnig and François G Meyer. "The Resistance Perturbation Distance: A Metric for the Analysis of Dynamic Networks". In: arXiv preprint arXiv:1605.01091 (2016). 37 [39] G Palla, AL Barabási, and T Vicsek. "Quantifying social group evolution." In: Nature 446.7136 (2007), pp. 664 -- 667. [40] Marianna Pensky. "Dynamic network models and graphon estimation". In: arXiv preprint arXiv:1607.00673 (2016). [41] Brandon Pincombe. "Detecting changes in time series of network graphs using minimum mean squared error and cumulative summation". In: ANZIAM Journal 48 (2007), pp. 450 -- 473. [42] Gyan Ranjan, Zhi-Li Zhang, and Daniel Boley. "Incremental Computation of Pseudo-Inverse of Laplacian". In: Proceedings of the 8th International Conference on Combinatorial Optimization and Applications. 2014, pp. 729 -- 749. url: http://dx.doi.org/10.1007/978-3-319-12691-3_54. Stephen Ranshous et al. "Anomaly detection in dynamic networks: a survey". In: Wiley Interdisciplinary Reviews: Computational Statistics 7.3 (2015), pp. 223 -- 247. [43] [44] D. A. Spielman and S.-H. Teng. "Spectral Sparsi(cid:27)cation of Graphs." In: SIAM J. Comput. 40.4 (2011), pp. 981 -- 1025. [45] Kumar Sricharan and Kamalika Das. "Localizing anomalous changes in time-evolving graphs". In: Proceedings of the 2014 ACM SIGMOD international conference on Management of data. ACM. 2014, pp. 1347 -- 1358. [46] Cornelis J Stam. "Modern network science of neurological disorders". In: Nature Reviews Neuroscience 15.10 (2014), pp. 683 -- 695. [47] Yizhou Sun, Jie Tang, Jiawei Han, Manish Gupta, and Bo Zhao. "Community evolution detection in dynamic heterogeneous information networks". In: Proceedings of the Eighth Workshop on Mining and Learning with Graphs. ACM. 2010, pp. 137 -- 146. [48] Xuning Tang and Christopher C Yang. "Detecting social media hidden communities using dynamic stochastic blockmodel with temporal Dirichlet process". In: ACM Transactions on Intelligent Systems and Technology (TIST) 5.2 (2014), p. 36. [49] Chayant Tantipathananandh, Tanya Berger-Wolf, and David Kempe. "A framework for community identi(cid:27)cation in dynamic social networks". In: Proceedings of the 13th ACM SIGKDD international conference on Knowledge discovery and data mining. ACM. 2007, pp. 717 -- 726. [50] Riitta Toivonen, Jukka-Pekka Onnela, Jari Saramäki, Jörkki Hyvönen, and Kimmo Kaski. "A model for social networks". In: Physica A: Statistical Mechanics and its Applications 371.2 (2006), pp. 851 -- 860. [52] [51] Ulrike Von Luxburg, Agnes Radl, and Matthias Hein. "Hitting and commute times in large random neighborhood graphs." In: Journal of Machine Learning Research 15.1 (2014), pp. 1751 -- 1798. James D Wilson, Nathaniel T Stevens, and William H Woodall. "Modeling and estimating change in temporal networks via a dynamic degree corrected stochastic block model". In: arXiv preprint arXiv:1605.04049 (2016). [53] Eric P Xing, Wenjie Fu, Le Song, et al. "A state-space mixed membership blockmodel for dynamic network tomography". In: The Annals of Applied Statistics 4.2 (2010), pp. 535 -- 566. [54] Kevin Xu. "Stochastic block transition models for dynamic networks". In: Arti(cid:27)cial Intelligence and Statistics. 2015, pp. 1079 -- 1087. [55] Kevin S Xu and Alfred O Hero. "Dynamic stochastic blockmodels for time-evolving social networks". In: IEEE Journal of Selected Topics in Signal Processing 8.4 (2014), pp. 552 -- 562. [56] Tianbao Yang, Yun Chi, Shenghuo Zhu, Yihong Gong, and Rong Jin. "Detecting communities and their evolutions in dynamic social networksâĂŤa Bayesian approach". In: Machine learning 82.2 (2011), pp. 157 -- 189. [57] Rose Yu, Huida Qiu, Zhen Wen, ChingYung Lin, and Yan Liu. "A survey on social media anomaly detection". In: ACM SIGKDD Explorations Newsletter 18.1 (2016), pp. 1 -- 14. 38
1509.04905
1
1509
2015-09-16T12:39:23
On the discovery of social roles in large scale social systems
[ "cs.SI", "physics.soc-ph" ]
The social role of a participant in a social system is a label conceptualizing the circumstances under which she interacts within it. They may be used as a theoretical tool that explains why and how users participate in an online social system. Social role analysis also serves practical purposes, such as reducing the structure of complex systems to rela- tionships among roles rather than alters, and enabling a comparison of social systems that emerge in similar contexts. This article presents a data-driven approach for the discovery of social roles in large scale social systems. Motivated by an analysis of the present art, the method discovers roles by the conditional triad censuses of user ego-networks, which is a promising tool because they capture the degree to which basic social forces push upon a user to interact with others. Clusters of censuses, inferred from samples of large scale network carefully chosen to preserve local structural prop- erties, define the social roles. The promise of the method is demonstrated by discussing and discovering the roles that emerge in both Facebook and Wikipedia. The article con- cludes with a discussion of the challenges and future opportunities in the discovery of social roles in large social systems.
cs.SI
cs
On The Discovery of Social Roles in Large Scale Social Systems Derek Doran Department of Computer Science & Engineering Kno.e.sis Research Center Wright State University, Dayton, OH [email protected] Abstract The social role of a participant in a social system is a label conceptualizing the circumstances under which she interacts within it. They may be used as a theoretical tool that explains why and how users participate in an online social system. Social role analysis also serves practical purposes, such as reducing the structure of complex systems to relationships among roles rather than alters, and enabling a comparison of social systems that emerge in similar contexts. This article presents a data-driven approach for the discovery of social roles in large scale social systems. Motivated by an analysis of the present art, the method discovers roles by the conditional triad censuses of user ego-networks, which is a promising tool because they capture the degree to which basic social forces push upon a user to interact with others. Clusters of censuses, inferred from samples of large scale network carefully chosen to preserve local structural properties, define the social roles. The promise of the method is demonstrated by discussing and discovering the roles that emerge in both Facebook and Wikipedia. The article concludes with a discussion of the challenges and future opportunities in the discovery of social roles in large social systems. 1 Introduction and Motivation Why do people choose to participate and interact with others in a social system? This basic question lies at the heart of many sociological studies that examine the nature of interactions in a community. The question is theoretically associated with the social roles of community members, which is defined as a qualitative description 1 capturing the circumstances and reasons under which they choose to interact with others. The concept of a social role is fundamentally based on the notion of a user's position within a social network [39, 62]. For example, with whom and how one decides to connect to others in a community is associated with how they are perceived by others [13], the power they hold [22], and their ability to spread information and influence others [98]. As a concrete illustration, consider a network of interactions among workers in a corporate office. Some workers have the social role "manager" as defined by who they are connected to socially: "managers" are responsible for the work of the "team members" he leads and report to an "executive". Any person in the corporate office network in a similar position, even if they report to a different executive and managers a different team, is still perceived to have the social role "manager". Extracting and understanding the social roles of a social system carries theoretical and practical importance. Theoretically, an analyst may integrate the social roles discovered in a social setting and the context of these interactions to formulate a thesis about the reasons why and how people interact within the system. For example, consider the typical interactions that may occur within a generic corporate office as well as the connotations of being labeled a "manager". Analysts could infer that "managers" interact with "team members" based on the initiatives and projects assigned to them by "executives". They may be required to balance the demands placed on them by executives along with the needs of the team, and serve as a broker that filters information from corporate leaders to others in the organization. Practically, the delineation of users by their social role facilitates the interpretation of complex social systems by simplifying their structure from connections among users to between roles [8, 78, 95]. It also enables meaningful studies of communities across time and context (e.g., different types corporate offices) by comparing the structure of interactions between roles that are common among them. For example, meta-analysis of the social roles roles and the interactions among them roles across different groups can help designers create effective physical and digital spaces for communities and organizations to grow within [44]. Social role analysis is also useful to identify the types of users that may become influential [40], and even reveal latent social structures within the systems [58]. This article presents a new method to discover the social roles that exist in large scale online social systems. The methodology is motivated by an analysis of the present art, which either: (i) requires an analyst to presume the existence of roles beforehand; and/or (ii) mines the roles using features about the users and the structure of the system that may not have a basis in social theory. The approach discovers social roles by clustering users by their conditional triad census, which is a vector capturing the types and orientations of three way relationships their ego-network is composed of. The method is applied to a network of interactions from an online social network (Facebook) and a collaborative editing platform (Wikipedia). An analysis of the quality of the resulting 2 clusters and the ego-network structure of prototypical users demonstrate the utility of the proposed method. The article concludes with a discussion about the many opportunities and challenges for future research in social role discovery for large scale social systems. This article is organized as follows: Section 2 reviews and assesses existing methods for social role discovery in large scale social systems. Section 3 introduces the concept of a conditional triad census and the proposed methodology. Section 4 analyzes the structure of the social roles mined from two large scale online social sys- tems. Important challenges and opportunities that remain in the analysis of social roles in large scale systems are presented in Section 5. Concluding remarks are offered in Section 6. 2 Discovering Social Roles Present methods to discover social roles in social systems may be classified into three types: (i) methods that define roles by notions of equivalence; (ii) methods that require the assertion of the roles existing in the system prior to analysis; and (iii) methods that define roles based on patterns among user attributes and system interactions. This section provides an overview of each type and their applicability to discover social roles in large scale systems. 2.1 Equivalence based role discovery Longstanding methods to identify social roles are based on finding users who are in "equivalent" positions [95, 9, 10, 11], which may be defined in one of three ways. Given an undirected network G = (V, E) of users V connected by a set of relations E, structural equivalence requires two users i and j to be connected to be exactly the same set of others. In other words, for every relationship (i, x) ∈ E that exists, the relation (j, x) must also exist. Under this definition, a user's social role is precisely defined by the people that she is connected to. This strict definition may not be useful in many settings because it is impossible for two users whose distance is greater than two in a network to fall under the same role. For example, two "managers" in an office that report to a common "executive" but have difference sets of subordinates are not structurally equivalent and would therefore not be classified under the same role. Isomorphic equivalence offers a broader definition of equivalent network positions. An isomorphism among two users in a network exist if there is a mapping π : E(a) → E(b) where E(a) is the set of relationships held by user a such that for every pair of users a, b ∈ E, we have (a, b) ∈ E(a) if and only if (π(a), π(b)) ∈ E(b). In other words, users a and b must have isomorphic ego-networks, which is a tuple (Ve, Ee) where Ve is the set of all users in the 2nd degree neighborhood of a user and Ee represents the directed relationships that bind the users in Ve together. This suggests that one could simply switch the location of user a and b and their connectivity to others 3 without disturbing the overall structure of the network. Practically, two "managers" in a network that report to an "executive" and lead the same number of "team members" would be isomorphically equivalent if the connectivity among the "team members" of the two "managers" were isomorphic. This equivalence definition thus captures a more intuitive notion for ascribing a user's role in a social system. A still broader class is regular equivalence, which requires the role of the alters of two users to be identical. Specifically, if R(x) is a function that assigns a user x to a role, we say users a and b are regularly equivalent if R(a) = R(b) and if every user n in the ego- network N (a) of a can be mapped to a user m in the ego-network of b such that R(n) = R(m). For example, "managers" would be regularly equivalent so long as they both connect to "executives" and "team members". Isomorphic and regular equivalences may be identified by performing a blockmodeling over the adjacency matrix of a social system [89]. Notions of structural, isomorphic, and regular equivalence are decades old theories that have been instrumental in many social network analyses [82, 25, 23, 91, 94, 30]. More recent work have used these notions to study inter- national relationships across institutions [69], firms [73], governments [101, 53], and to study peer influences [36]. Isomorphic equivalence has been applied to hospitals within referral networks [50] to discover closed communi- ties of health services and hospitals that carry identical areas of expertise. They are also employed in the study of citation networks [85] to identify researchers within an organization that perform similar research and offer similar domain expertise. Regular equivalences have been studied in networks of relations among gang members in urban settings [75] and of relations among cities across the world [2]. 2.2 Implied role discovery In implied role analysis, a researcher defines the set of social roles users of a social system are expected to exhibit before any data or structural analysis commences. It is a qualitative, iterative process that generally follows the workflow of Figure 1. Based on at-hand information about a social system, roles are first defined based on the subset of functionality allowed by the system that the user may perform. For example, consider an online forum where users may decide to browse conversations but never post, or can become an administrator that edits and controls the behavior of others in the system. An analyst may therefore first define the social roles lurker (one who never posts), moderator (one who controls behavior), and poster (one who contributes to conversations). With these roles assumed to exist, the analyst studies the actions of users and their relations with others. The initial definitions of the social roles are then iteratively refined as evidence from the social system is collected. Implied role analysis is useful when a social system is well understood, highly structured, and if the analyst wishes to understand the interactions among users on the basis of the kinds of operations they perform. For 4 Figure 1: Workflow for implied-role analysis example, Nolker et al. tapped into their experiences with online bulletin board systems to predefine members of a Usenet group into the roles leader, motivator, and chatter [71]. They identified the behavioral attributes that are indicative of each role, and labeled users exhibiting such behaviors in a log of the group's activity. Golder et al. also studied Usenet groups but proposed a different taxonomy of roles that include celebrities, ranters, lurkers, trolls, and newbies [41]. They sifted through conversations across different Usenet groups to study behaviors associated with each role. Gliwa et al. examined collections of online bloggers and defined the roles selfish influential user, social influential user, selfish influential blogger, social influential blogger, influential commentator, standard commentator, not active, and standard blogger [40]. Welser et al. defined four roles for Wikipedia users, namely substantive experts, technical editors, counter vandalism, and social networkers [92]. They subsequently searched for patterns about how users contribute and interact with others in order to classify the users falling in each role. 2.3 Data-driven role discovery A third type of approach is to infer social roles by the features of a dataset without pre-defining the roles that exist. These data-driven approaches, whose workflow is summarized in Figure 2, generally considers features about users and the structure of their ego-networks in an unsupervised machine learning algorithm. Social roles are defined as the groups the algorithm places users into based on the similarity of these features. Studies that apply unsupervised learners for social role discovery vary in sophistication. For example, Hautz et al. categorized users in an online community of jewelry designers by mapping whether their out- and in-degree distributions and frequency of interactions to "low" or "high" levels [44]. Zhu et al. use k-means clustering to identify user roles in a network of phone calls based on similar calling behaviors, ego-network clustering coefficients, and mean geodesic 5 Figure 2: Workflow for data-driven role analysis distances between users [102]. Chan et al. discover roles by agglomerative hierarchical clustering with over fifty behavioral and structural features of users' across the post/reply network of many online forums [18]. White et al. use a mixed membership probabilistic model to identify roles across online forums using behavioral features and found a number of possible assignments of users into groups [93]. Rowe et al. use behavioral ontologies and semantic rules to automatically group online forum users into roles based on the content of their posts [77]. Although data-driven approaches define similarity based on the structural features of ego-networks, this class of methods is not an approximation of equivalence based role discovery. This is because data-driven methods may search for the similarity of two users based on many feature types that are not structural, including their personal attributes, their behaviors on the social system, and the content of their interactions with others. 2.4 Comparative analysis The recent availability of data about very large scale social systems, typically collected from online social networks (Facebook; Google+), social media (Twitter; Tumblr), and innovative information exchanges (Wikipedia; StackExchange) enables the study of the social roles of users in systems that have a world-wide reach. The massive scale of these systems necessitates the need to evaluate current approaches for discovering social roles, so that the most effective type given their size can be identified. Equivalence based role discovery comprises a number of well-studied, longstanding methods that has deep roots in sociological theory. Unfortunately, it may be infeasible to precisely identify users falling into isomorphic 6 or regular equivalence classes within large scale social systems. This is because the problem of finding isomorphic ego-networks is closely aligned to searching for all motifs of arbitrary size within the network, and the problem of identifying regularly equivalent positions is related to searching for a k-coloring of G, with k unknown a priori (both are NP-hard problems [52]). Researchers still interested in identifying these equivalences in large systems must resort to numerical approximations based on quantitative notions of structural similarity between two users that may be difficult to apply and analyze in practice [70, 32, 49]. Thus, despite the rich theory they are grounded within, technical challenges bar its adequate adaptation for large scale social systems. Implied role analyses carry fewer technical challenges. This is because the most difficult aspect - identifying the roles that exist - are predefined by an analyst before trends in the data are considered. However, implied role analyses runs the risk of using noisy signals in the data that appear by chance as evidence for the roles they have predefined. Furthermore, it is possible for separate analysts to define completely different sets of social roles for the same system, which may confuse or conflict each other. For example, Nolker et al. places Usenet members into leader, motivator, and chatter roles [71]. Are these roles compatible with the alternative set of celebrities, ranters, lurkers, trolls, and newbie roles proposed by Golder et al. for the same system [41]? It is unclear if one set of roles is more suitable than the other, or if the cross-product of the two types of roles (e.g. leader-celeberty or chatter-lurker) is also a valid set of roles. Furthermore, the implied roles tend to speak to the functionality or actions that users of the social system undertake instead of reflecting the reasons why they participate in the system and the way they are structurally embedded within it. Thus, although there are fewer technical challenges to run implied role analysis over large scale social systems, the resulting roles may have a weak relationship to sociological theory. Data-driven social role analysis may be a promising type of approach for the discovery of social roles in large- scale social systems. This is because modern day "big data" technologies enable the collection of incredible amounts of information about each user, their connections with others in the social system, and the details or the content of their interactions. Instead of assuming that specific kinds of social roles in the system must exist, data-driven analyses apply data mining algorithms or learn data models from which the social roles of the system emerge. Such approaches let the data inform the analyst what social roles exist, rather than require a definition of the roles before studying the data. Fortunately, recent big data systems and methods research enable the rapid mining and building of data models from large social systems. For example, Zhang et al. tackle computations over real-world and virtual social interaction data by performing Tucker decompositions of a tensor representation of the interactions [99]. A distributed learning algorithm based on the MapReduce proposed by Tang et al. efficiently identifies the influencers and experts latent within large social systems [84]. Cambria et al. use a comparative anal- 7 ysis of the performance of multiple natural language processing algorithms to find patterns in the content of social interactions [16]. Giannakis et al. present a series of articles that describe how sensor signal processing algorithms may be adapted to operate over big and social data sets [38]. Malcom et al. even developed a uniform program- ming interface so that non-experts can utilize state-of-the-art big data technologies [63] for social role analysis. However, the relationship of such analyses with longstanding social theory varies considerably. This is because while some data mining algorithms and models encode aspects of social theory in their technical development, others were given no consideration to these theories in their development or make assumptions that are incompati- ble with past social science research for sake of model tractability. Furthermore, algorithms and models for social role analysis may use features that do not reflect aspects of social forces that drive users to embed themselves in the network in a specific way [18]. 3 Triad-based Social Role Extraction In this section, a new data-driven approach for extracting social roles from large social systems is introduced1. Based on the discussion in the previous section, it only considers features that have a grounding in social theory, namely the conditional triads that compose each user's ego-network. After network sampling and dimensionality reduction, k-means clustering is applied to the vectors to identify social roles. Ego-networks falling closest to the centroid of each cluster is interpreted for role analysis. This section describes what conditional triads are, the triad-based representation of an ego-network, the social systems used to illustrate the methodology, and the role extraction process. 3.1 Conditional Triad Census In social network analysis, a triad is a group of three individuals and the pairwise interactions among them [79]. They are the smallest sociological unit from which the dynamics of a multi-person relationship can be observed, and hence, are considered to be the atomic unit of a social network [33, 90, 24]. For example, third actors may act as a moderating force that can resolve conflicts among two others [13]. They may also sabotage an existing relationship or induce a feeling of unwelcomeness to a specific alter [7]. Such observations have been used to develop theories that associate the configuration of a triad to specific underlying effects that promote specific kinds of social interactions [46, 6]. Figure 3 captures the 36 different ways an individual (white) can be oriented towards two alters (blue) within a 1Parts of this method were presented at the First Workshop on Interaction and Exchange in Social Media at the 2014 International Conference on Social Informatics [27]. 8 Figure 3: Types of conditional triads triad [15]. These orientations are the set of all conditional triads, which are defined by the structure of the three way relation based on the position of an individual within it. For example, triads 6 and 11 are structurally identical (having two null and one mutual tie). In triad 11, the white user is isolated whereas in triad 6 she is connected to an alter. The entire structure of an ego-network can thus be represented by the number and different types of conditional triads it is composed of. The conditional triad census [89, 28] of an ego-network is defined as a 36-element vector whose ith component represents the proportion of type i conditional triads it is composed of. Searching for ego-networks whose conditional triad censuses are similar is expected to lead to a meaningful grouping of users into social roles. This is because each triad configuration represents a sociological factor about how a user interacts with others [17]. For example, triad 32 has a user on the receiving end of a chain of interac- tions. If these interactions represent the passage of information or rumors, it implies that the alter in the middle of the chain is capable of manipulating what becomes shared with the user and may not be trustworthy. In triad 5, the user receives interactions from two alters but chooses not to reciprocate. Ego-networks largely composed of this triad suggests that the user receives many interactions but, for possibly selfish reasons, seldom chooses to reciprocate. By summarizing how frequently each of these triads appear, a conditional triad censuses succinctly models the strength of the different kinds of social factors that surround the nature of one's interactions with others. These factors, taken together by considering the entire census as a vector, therefore represents the circumstances and reasons why a user participates in a social system. The number of and kinds of roles that exist in a social system can thus be identified by: (i) computing the conditional triad census of every user; and (ii) clustering users into groups based on the similarity (vector distance) of the conditional triad censuses. This approach is somewhat related to discovering social groups in networks by 9 Network Facebook V 46,952 E ¯d ¯C αin αout 264,004 37.36 0.085 1.61 (p > 0.732) 1.68 (p > 0.964) Wikipedia 138,592 740,397 10.68 0.038 1.54 (p > 0.999) 1.83 (p > 0.999) Table 1: Dataset summary statistics searching for ego-networks that participate in similarly shaped k-cliques [43] or -cores (sub-graphs where all nodes are connected to at least k others [29]) [48, 76, 56]. However, searching for ego-networks that satisfy these strict requirements will only identify sets of nodes surrounded by a similarly dense network and leave hidden other nodes whose ego-networks are less connected but still have similar connectivity patterns. Such analysis also pays no consideration to the social forces or actions that drive users in cliques or cores to interact with each other, since the types of triads within the groups are ignored. Furthermore, it is difficult to know a priori what kinds of k-cliques and -cores correspond to relevant social roles in a large-scale social system. In comparison, the proposed approach learns significant structural patterns of ego-networks based on a feature reflecting the types of social forces that bind a user and her connections together. It leads to a classification where users in the same group participate and interact with their contacts under similar social circumstances and forces, which speaks very closely to the notion of a social role. 3.2 Dataset description The methodology is demonstrated by discovering social roles in two popular online social systems, namely Facebook and Wikipedia. These systems were chosen because they each serve a different purpose and provide distinct mechanisms for users to interact with each other. Facebook is used as a platform to informally share personal information, photos, and events with friends and family. Its interaction network is built by placing a directed edge from user a to b if a posts at least one message on the wall (a collection of public messages) of b. Wikipedia is an online encyclopedia with articles that are written and edited by an open community. Interactions on Wikipedia are defined by the modification of content contributed by another user; a directed edge from a to b is added if a edited the text, reverted a change, or voted on approving an action to an article made by b. Both the Facebook and Wikipedia networks were constructed from publicly available datasets [87, 64]. These datasets only record the act of an interaction; it does not include any information about the content of or the type of the interaction. Although the Facebook data set is dated (interactions were recorded in 2009), privacy improvements made to the Facebook API since make it all but impossible to capture such interactions at scale today. Table 1 presents summary statistics for these interaction networks, illustrating how they vary in size, shape, and 10 Figure 4: In- (top) and out-degree (bottom) distributions user behaviors. The relatively small size (46,952 users, 264,004 pairwise interactions) of the Facebook network is due to the fact that it only represents users within a single regional network (the Facebook social graph was divided by user regions in its earliest form). The data also only represents user's whose accounts were shared publicly, which was the default Facebook setting during the data collection period [87]. Despite its size and limit to a single regional network, previous work showed that all regional Facebook networks exhibited a similar structure (average path lengths and diameter) and shape (clustering coefficients and assortativity) [96]. More recent studies further confirm that the structure and shape of these regional networks are very similar to the structure of the modern global Facebook network [97, 86]; therefore this data set is expected to contain similar interaction patterns as seen in the global Facebook network. The Wikipedia network is almost three times the size of Facebook, with 138,592 users and 740,397 distinct pairwise interactions, but its clustering coefficient ¯C is approximately 55% smaller. These measurements suggest that Facebook users have a greater tendency to surround themselves within denser ego-networks compared to Wikipedia users. The lower clustering coefficient of Wikipedia could be explained by users who generally limit themsleves to modifying articles written by a specific group (perhaps representing a specific topic). The in- and out-degree distributions of each network is presented in Figure 4, which exhibit power-tailed shapes. The existence of power-law behavior is tested by a maximum likelihood approach [21] and the resulting power- 11 12510501e−041e−01FacebookIn−degreePr(X > x)1101001000100001e−051e−01WikipediaIn−degreePr(X > x)12510502001e−041e−01Out−degreePr(X > x)15505001e−051e−01Out−degreePr(X > x) law exponents αin,out are given in Table 1. The estimates of the power-law exponent are very reliable (p > 0.95; note that the test considers the hypothesis H0: the empirical data follows a power-tailed distribution) except for the in-degree distribution of Facebook, which may be because its range only covers two orders of magnitude. A larger power-law exponent indicates that the distribution drops to zero faster in its right-tail [61], hence the frequency with which users interact with others on Wikipedia exhibits a smaller amount of variation compared to Facebook. In other words, it is less likely to find a user who interacts with an unexpectedly high number of others on Wikipedia compared to Facebook, and less likely to find a user receiving many interactions from others on Facebook compared to Wikipedia. 3.3 Network sampling Computing the conditional triad census of every ego-network requires an examination of O(V 3) triples of users in an interaction network. This computational cost may be an insurmountable burden to compute conditional triad censuses in larger interaction networks where the number of nodes are in the millions [86]. Furthermore, existing algorithms that can compute censuses in O(V 2) [68] or O(E) [5] only considers users' unconditional triad censuses. An unconditional triad census is a 16-element vector holding the proportion of all triads without regard to the position of the user in her ego-network, making them incompatible with the proposed approach. However, since the components of a conditional triad census are the proportions of triad types in an ego-network, the conditional censuses within a carefully selected sample of the original network should be representative of the conditional censuses in the original network. A sample of a network G is a new network Gs = (Vs, Es) where Vs ⊂ V , Es ⊂ E, and Vs = φV with 0 < φ < 1. A sampling method must ensure that the two critical local structural properties of ego-networks, namely the degree distribution and local clustering coefficient distribution are preserved [46, 31]. For example, ego-networks with high degree will naturally tend to have triads with relations among multiple alters, and lower (higher) cluster coefficients indicate a greater proportion of open (closed) triads. However, naıve methods for network sampling do a poor job of preserving these local features. A number of advanced sampling methods have been proposed, but each one can only preseve different types of structural features of the full network [1]. Therefore, four widely used graph sampling techniques for choosing Vs and Es were compared by their ability to preserve the degree distribution of the users' ego-network and their clustering coefficients. The techniques and their process are: 1. Vertex Sampling (VS): Let Vs be a random sample of φV vertices from V and define Es to be the set of all edges among the vertices in Vs from G. 2. Edge Sampling (ES): Randomly choose an edge e = (v1, v2) from E, add it to Es, and add v1 and v2 to Vs 12 (a) Facebook (b) Wikipedia Figure 5: Comparison of graph sampling methods if they have not yet been added. Continue to choose edges from E until Vs = φV . 3. Forest Fire Sampling (FFS) [59]: Choose a random vertex v from V , randomly select p/(1 − p) of its outgoing edges, and add theses edges to Es. Place every vertex incident to those added to Es into a set V∗ of 'burned vertices' and update Vs by Vs = Vs ∪ V∗. Randomly choose a burned vertex from V∗, and recursively repeat this process until Vs = φV . The parameter assignment p = 0.7 is used based on the recommendation of the method's authors [59]. 4. ES-i (ESI) [1]: Randomly choose an edge e = (v1, v2) from E and add v1 and v2 to Vs if they have not yet been added (note that e is not added to Es). Continue sampling until Vs = φV . Finally, define Es to be the set of all edges among the vertices in Vs from G. The Kolmogorov-Smirnov distance metric D was used to compare how closely the degree and clustering coef- ficient distributions of samples Fs taken with each method follow the distribution of the original network F . It is 13 0.00.20.4Degree DistributionProportion of Vertices SampledKS−Statistic10%30%50%70%FFSESIVSES0.00.20.4Degree DistributionProportion of Vertices SampledKS−Statistic10%30%50%70%0.00.20.40.6Cluster CoefficientProportion of Vertices SampledKS−Statistic10%30%50%70%0.00.20.4Cluster CoefficientProportion of Vertices SampledKS−Statistic10%30%50%70% (a) Facebook (b) Wikipedia Figure 6: Triad Role Census Sample Values with 95% Confidence Intervals defined by the largest difference of a point taken from original distribution F to the distribution of the sample Fs: Fs(x) − F (x) D = sup x Figure 5 compares the average D over 100 samples taken by each method for different values of φ. For the Face- book network, FFS does the best job (D < 0.2) at preserving both degree and clustering coefficient distributions for modest sample sizes (φ ≥ 0.33). FFS samples of the Wikipedia network best preserves the clustering co- efficient distribution for any sample size and 0.2 < φ < 0.3 FFS and VS are similarly faithful to the original network's degree distribution. Ultimately, FFS sampling is found to be able to preserve the local structure of both networks even for small sample sizes. A value of φ that provided a reasonable trade-off between computational speed and sample consistency was searched for. Figure 6 plots the average value of each component of conditional triad censuses taken from n = 20 independently generated FFS samples of each network for φ = 0.35 (triad 1 is excluded because of its dispro- portionately high frequency) and the 95% confidence interval of the proportions. The proportion of triad types across the samples are similar and feature small confidence intervals. Since the computation cost of computing triad censuses at this sampling level is very reasonable (less than 30 minutes in a parallel computation over three cores of an Intel i5 processor), the setting φ = 0.35 is used for role analysis. 3.4 Census clustering k-means clustering, a common and flexible algorithm for discovering latent groups in data [45, 100, 37], is used to separate users into roles. k-means clustering defines k centroid positions in the vector space and assigns each conditional triad census (and hence user) to a cluster based on the centroid it is most similar to. Since the components of the censuses take a value between 0 and 1, this similarity is defined as the (cid:96)2-norm of their 14 0.000.10Facebook (35% sample)Triad TypeNormalized Census Value258121620242832360.000.10Stack Overflow (35% sample)Triad TypeNormalized Census Value25812162024283236 (a) Facebook (b) Wikipedia Figure 7: Scree plots difference vector. After the assignment of conditional triad censuses to clusters, the position of the centroid of each cluster is updated. Censuses are then reassigned to their closest centroid, and the process repeats until there are no changes to any cluster assignments. 3.4.1 Dimensionality reduction Figure 6 indicates that many components of the conditional triad censuses are close to or equal to 0. A dimension- ality reduction technique, namely principle component analysis (PCA) [47], is therefore applied to the conditional triad censuses. PCA identifies a projection of the data into a lower dimensional subspace that preserves as much variation within the original space as possible. Figure 7 plots the proportion of variation within the original dataset that is retained when we use PCA to reduce the data into smaller numbers of principle components. The smallest dimensional space that still preserved a large proportion of the variation in the data (> 85%) was chosen, as indi- cated by the red line in Figure 7. The figure suggests that PCA finds a significantly lower dimensional space for clustering the conditional triad census of every network, from 36 dimensions to just 6 and 3 for the Facebook and Wikipedia interaction networks respectively. 3.4.2 Clustering evaluation k-means clustering requires the number of clusters k to divide the data into to be chosen beforehand, forcing an analyst to assert the specific number of social roles that may exist in the system. Instead, the silhouette coefficient metric [83] SC Ck is used to quantitatively evaluate the quality of clusters for different values of k, so that the k yielding the 'best' clustering is chosen. It is defined as follows: consider a division of censuses into k clusters Ck = {C1, C2, ...Ck}. Let α(x) = d(x, C∗ i of its i ), x ∈ Ci be the distance from the vector x to the centroid C∗ 15 2468100.30.50.70.9FacebookPrinciple ComponentsCumulative Proportion0.8592468100.60.70.80.91.0WikipediaPrinciple ComponentsCumulative Proportion0.887 (a) Facebook (b) Wikipedia Figure 8: Silhouette coefficients j ) be the distance from assigned cluster Ci (measuring intra-cluster distance) and β(x) = minCj∈ Ck,Cj(cid:54)=Ci x to the centroid of the nearest cluster Cj x is not assigned to (measuring inter-cluster distance). The silhouette of x is defined as: d(x, C∗ φ(x) = β(x) − α(x) max(β(x), α(x)) Note that φ(x) approaches 1 as the separation between the cluster x is assigned to and the nearest other cluster increases. The average silhouette of every clustered vector defines the silhouette coefficient of a clustering Ck: (cid:80) SC Ck = x∈X φ(x) X where X is the set of all data vectors. Previous studies indicate that values of SC Ck greater than 0.7 means the algorithm achieved superior separation, and values between 0.5 and 0.7 indicate a reasonable separation [83]. For a given value of k, we ran 50 k-means clusterings over the PCA-reduced conditional triad censuses using different random initializations of the centroid positions. Figure 8 plots the average SC Ck of these trials for 2 ≤ k ≤ 9. It reveals excellent clustering solutions at k = 3 and k = 2 clusters for the Facebook and Wikipedia censuses, with silhouette coefficients of 0.73 and 0.90, respectively. A qualitative validation of the adequacy of a clustering solution is also given in Figure 9. Here, the conditional triad censuses in a space defined by the first three principle components are assigned a marking and color corresponding to their cluster assignment. The Facebook clustering solution, given in the top panels of the figure, discovers a role (the red cluster of circle points) that exhibits large variation along two principle components. In contrast, a second role (the green cluster of square points) varies strongly along the third component. The smallest cluster (blue cluster of triangle points) only varies along the first component. Since the clusters exhibit little variation along different directions, different subsets of conditional triads must appear in similar proportions within the censuses of the same group. The Wikipedia 16 0.450.550.65FacebookNumber ClustersSilhouette Coefficient23456789100.700.800.90WikipediaNumber ClustersSilhouette Coefficient2345678910 (a) Principle Comp. 1 and 2 (b) Principle Comp. 1 and 3 (c) Principle Comp. 2 and 3 Figure 9: Clusters along the first three principle components for Facebook (top) and Wikipedia (bottom) clustering solution, given in the bottom panels of Figure 9, also finds that the two clusters vary along the direction of different principle components: the red cluster of circle points vary along the second and third components, while the blue cluster of triangle points mainly varies along the first component. 4 Triad-based Role Analysis In this section, the kinds of social roles that emerge from our clustering analysis is analyzed. For this purpose, the average centroid positions C∗ i whose conditional triad census is located closest to C∗ i is defined as the "central user" of role i whose ego-network is the "central structure" of the role. Due to its position in the cluster, this "central structure" represents the way i over a clustering result was identified and the user u∗ i was found. u∗ a prototypical user having this role embeds herself within the social system. In other words, the ego-network structure of users in role i are most similar to C∗ i compared to any other central structure on the network. Each central structure is given a social role label based on a subjective interpretation of the user's position within it. The label captures the way users of a role interact with others in the system, and how the structure representing a role affects the kinds of interactions that are possible. The role labels may not be applicable to all social systems, although it is feasible that systems created under a similar context (e.g. social sharing sites) exhibit similar central role structures and labels. The central role structures discovered in the Facebook and Wikipedia networks, and 17 Role label Structure Proportion of users Social Group Manager Figure 10(a) Exclusive Group Participant Figure 10(b) Information Absorber Figure 10(c) 56.6% 28.4% 15.0% Table 2: Facebook roles support for the emergence of these roles in the literature, are presented next. 4.1 Facebook Figure 10 presents the central role structures of the three social roles found on Facebook. A label representing each role structure and the proportion of users falling under each are presented in Table 2. In these figures, the red node (with a red arrow pointing to it) corresponds to the central user and the blue nodes are the members of her ego-network. The structure in Figure 10(a) represents a social role the majority of all Facebook users (56.6%) fall into where a user is centrally embedded between many disconnected groups of others. She lies in a position critical for maintaining connectivity between communities, and hence, lies in the brokerage position of many open triads. These many open triads give users in this role many opportunities to control if and how information exchanges from one group to another. However, given the fact that Facebook is used as a platform for social sharing, such users may never decide to share information between communities when they represent different social circles. For example, one can envision the user in Figure 10(a) to be sitting between groups that may correspond to colleagues at work, relatives, personal friends, and work colleagues. A user may never want personal information shared among relatives to be revealed by work colleagues, and may want conversations, rumors, and other information shared among friends to never be exposed to family members and work colleagues. That a majority of Facebook users fall into a social role that brokers among many disconnected circles is not surprising; many past research studies have shown that most Facebook users face identity management and multiple presentation issues while interacting on the site [26, 81, 4, 57]. Identification of these "social group managers" is thus a way of finding the bridges or weak ties [14] in the network based on structural patterns rooted in social theory. 28.4% of Facebook users fall into the role represented by the central structure of Figure 10(b). This structure represents a user that has surrounded herself around a web of interactions running between her first-degree con- nections. This small percentage of users only participates in a single, tight-knit community of others rather than managing many disconnected groups. Such a role may represent users who only choose to 'friend' and interact with a collection of others that share many mutual connections, and does not need to manage multiple discon- 18 (a) (b) (c) Figure 10: Central role structures: Facebook nected social circles. Such patterns are known to be more prominent in the ego-networks of Facebook users who are more willing to share information with many others, or does not feel a need to consider identity management on the social network [42, 65, 74, 12]. Such "exclusive group participants" may therefore promote the use of Face- book as a genuine social sharing platform, and be instrumental in the development of dense interaction clusters in the structure of the network. Figure 10(c) corresponds to the 15% of users who are positioned at the periphery of a single alter that interacts with many others. Since the structure corresponds to an average or typical ego-network structure for users in this role, it signifies a group of users who are passive and seldom share information with others. When they do share, it tends to be with those who the user has a mutual association with. Furthermore, these users tend to receive information from alters that share prolifically. The phenomenon of over-active or extraordinarily well connected users on online social systems is well-studied [67, 54, 55], but it is interesting to discover that the users connected to them to also play an important role in the online system. These users 'absorb' the information of the over-active others, since they only forward such information to those already connected to the over-active source. In fact, a modern use of the Facebook platform is to "absorb information" from friends and news organizations rather than to share social information, as reflected by this social role [3, 80, 88]. 19 Role label Structure Proportion of users Interdisciplinary Contributor Figure 11(a) Technical Editor Figure 11(b) 89.7% 10.3% Table 3: Wikipedia roles 4.2 Wikipedia The density of the central structures of the Wikipedia social roles shown in Figure 11 is a result of the many different ways interactions are defined, which includes content editing, reverting a change, or voting on a pending action by another user. The triad-based analysis revealed two types of roles in Wikipeida. The first role is taken on by the majority of all users (89.7%) and has the central structure shown in Figure 11(a). The structure shows a user whose work is being changed by active alters that make changes to articles from many other authors as well. It is interesting that these the active alters seldom edit content added by a common individual (e.g. have few mutual connections), even though they are prolific editors. Such a pattern may emerge when these alters have different expertise and concentrate on editing contributions that fall within their specific domain. The existence of these 'hubs' of editing activity is not a surprising finding, as past work has confirmed that most editors on Wikipedia do exhibit domain-specific expertise and limit their edits articles in their domain [92]. Users falling under this structure must therefore be contributing to interdisciplinary articles, which most Wikipedia articles are classified as [66]. Such "interdisciplinary contributors" represent the vast majority of users (89.7%) and is thus the primary role that adds information to Wikipedia. The remaining 10.3% of users fall under the role whose central structure is given in Figure 11(b). Two alters that take the form of a hub (a domain-specific expert) can be seen, but the overlap between them is larger and denser in comparison to Figure 11(a). The central user is positioned within this overlap. Users in this role therefore edit the contributions of many, and find their contributions edited by many others as well. A plausible explanation for finding a dense core between the positions of domain experts is that they perform 'general' edits that reflect the language, grammar, spelling, hyperlinking, and structure of articles. Changes made by these "technical editors" may be further refined by a large number of other editors to further refine the technical discussion or the presenta- tion and language of an article. This explanation is compatible with past observations of users that concentrate on edits related to the language and format of an article [92]. In summary, the analysis demonstrates the use of conditional triad censuses to extract social roles from different 20 (a) (b) Figure 11: Central role structures: Wikipedia types of online social systems. It naturally discovered social roles on Facebook corresponding to users who maintain connectivity across many disconnected social groups (" social group managers"), who participate in well- connected groups ("exclusive group participants") that generate many social interactions, and passive users that serve as an outlet for over-active others to share information with ("information absorbers") and may use Facebook as a platform to receive news. The roles discovered on Wikipedia focuses on the nature of the user's contribution to the content of the online encyclopedia. A majority of users ("interdisciplinary contributors") are devoted to articles that attract the attention of editors focusing on different subsets of articles, which may correspond to the actions of a domain-specific expert. The attraction of many experts suggests that the article the central user focuses on is interdisciplinary in nature. A minority of users ("technical editors") edit many articles at once, and have their articles edited by many others as well. These users may thus be domain-specific experts or could be users that apply general language and formatting changes to many articles on the site. 4.3 Applying social role analysis Triad-based social role analysis offers not only insights into the nature of user behaviors on social systems, but also a practical tool for exploring social theories. For example, consider a researcher wishing to study whether or 21 (a) (b) (c) Figure 12: Central role structures: UC Irvine online network not the reasons and ways users interact with each other on Facebook is due to its inclusive, public nature. This research question may be explored by comparing the social roles that emerge on Facebook with a different online social network that is not inclusive and public, but exclusive and private. Differences in the number, shape and proportion of users falling into social roles across the two systems may give evidence of a relationship between the public or private nature of a social system and why people participate in it. To illustrate this, a data set of interactions recorded from a private online social network for students at the University of California Irvine (UC Irvine) is considered [72]2. The six-month long data set consists of 1,899 ties between users, with a directed tie from user A to B established when A sends at least one message to B. Triad-based social role analysis on the UC Irvine network revealed the best clustering solution at k = 3 roles ( Ck = 0.713). Figure 12 visualizes the central structure of the resulting role clusters, which exhibit very similar features to the central structures of the social roles on Facebook. For example, Figures 10(a) and 12(a) both have a user situated between two groups of others, Figures 10(b) and 12(b) find the user in the center of a well connected community, and Figures 10(c) and 12(c) shows the user sitting at the periphery of a highly active alter. An analyst may therefore consider the two networks to exhibit the same social roles, and hence, conclude users utilize the network for similar reasons and in similar ways. Given the fact that Facebook and the UC Irvine social networks were created to facilitate social 2It should be emphasized that a complete study of this research question requires a comprehensive analysis of user behaviors, and extensive comparisons between many different social network datasets. The illustration that follows is limited, and is only meant to demonstrate how social role analysis can be used as a useful research tool. 22 Proportion of Users Role Label UC Irvine Facebook Social Group Manager Exclusive Group Participant Information Absorber 3.06% 92.9% 4.04% 56.6% 28.4% 15.0% Table 4: Comparing the proportion of social roles on Facebook and UC Irvine networks communication and connection, it is not surprising to find similar roles and central structures emerging. Comparison of the shape and the proportion of users falling into the central role structures, however, reveal significant differences between the private UC Irvine and public Facebook online social networks. For example, the central role structure of social group managers in the UC Irvine network finds the ego to be situated between a smaller number of groups compared to Facebook, and has an additional alter managing the same set of social groups. These differences may arise because the separate groups an individual participates in within a private social network that is smaller in scope and encompasses fewer types of people may be less than a public social network that can include family, social, and work contacts. Furthermore, Table 4 shows the proportion of users falling into the social roles of the two networks to be very different. The majority of users in the UC Irvine network are exclusive group participants, that is, they are found to be embedded within a tight social group and do not need to manage a membership in many separate ones. In fact, only 3.06% of UC Irvine users act as a social group manager, compared to the 56.6% of Facebook users that take on this role. This difference may be rooted in the fact that its users are all students of UC Irvine, and hence, may exhibit homopholic tendencies through common class, standing, housing, major, college, and club affiliations. The many ways by which users could exhibit homophily on the UC Irvine network may also explain why the social group manager central structure has an alter managing the same set of groups as the ego; both could be managing groups of colleagues from the same class and club. The public nature of Facebook, however, may be reducing the level of homophily among a user's connections. An analyst may point to these findings as key differences between public and private online social networks, and as a rationale to explore new hypotheses involving a comparison of homopholic tendencies within them. 5 Further Opportunities for Large Scale Social Role Analysis Based on the related work discussed in Section 2 and on a reflection of the proposed triad-based method, this section summarizes additional challenges and opportunities that exist in social role analysis for large scale social systems. Opportunities along two important directions are considered: (i) finding meaningful features for role 23 extraction; and (ii) understanding the relationship between functional and social roles. 5.1 Linking representation with social theory As discussed in Section 2.4, many data-driven analyses select a large collection of structural, user, and relation- ship attributes, and use them all to discover the social roles within a system. However, this may be a dangerous practice because the resulting roles are defined to be according to the 'similarity' of a complex mixture of many variables. Furthermore, many quantitative structural, user, and relationship features do not necessarily have a close correspondence to a sociological theory that is related to the concept of a user role. For example, structural features such as the clustering coefficient or betweenness centrality of a user within her ego-network can quantify how clus- tered its structure is, but does not identify the telling patterns of the interactions within it. Analysis that use a large number of features thus lead to a separation of users into roles that must be defined very broadly, or where ego- network structures within roles may be discordant and have have few interpretable structural regularities. Some methods using a large collection of features also apply post-processing steps to the resulting groups [18, 102], which may further distort any interpretation of the extracted roles. This article takes a step toward the exclusive use of features that carry a specific social interpretation. However, it may be the case that additional features associated with social theories may improve the fidelity of the method's results, or that a different unsupervised learning algorithm should be used. For example, Field et al. note the importance of preserving not only interactions, but also affiliation information between users in a social system to define their position [34]. Such a concept may be operationalized in a richer dataset containing affiliation information, by incorporating similarity measures of the rows of a g × n binary incidence matrix whose ith row and jth column is 1 if user j is affiliated with group i. Another related concept is the importance of social influence to the way it impacts a user's social role [35]. Fortunately, there have been many measures proposed for quantifying influence that may be integrated into the social role mining process [73, 36, 19, 60, 20, 51]. It is these kinds of factors, instead of conveniently chosen structural and user features, that should be considered when grouping users into social roles. 5.2 Linking functional and social roles In an offline setting, people can interact, converse, and exchange ideas with each other in virtually innumerable ways. However, most large scale social datasets come from online systems that only offer a limited number of well-defined ways for people to interact with one another. It may be intuitive to think that these modes of interactions, which reflect the functional ways users participate on the social system, are associated or have an 24 effect on the social roles they go on to exhibit. For example, the roles identified over Wikipedia in this article were more closely related to the types of interactions allowed by the service (as an expert editing content or a generalist editing language form). The functionality provided by Facebook may also have helped users fall into specific social roles; for example, users only participating in a cooperative group of others may leverage the ability to choose what friendships to accept on Facebook, so that the group they are embedded in is cohesive. The idea that users can only interact with others in a limited number of ways is a unique property of online social systems compared to offline ones. Thus, advanced features used to discover social roles may also need to be associated with the different functionalities of an online social service, with values that reflect what functions and how frequently they are used. Such features that are found to be 'significant' across classes of users falling under the same social role may signal an association between the functionality of a social system and its social roles. 6 Concluding Remarks This article presented a methodology to discover social roles in large scale social systems. The data-driven approach, rooted in the representation of ego-networks as a conditional triad census and implemented with a simple unsupervised learner was applied to two different online social systems. Structural analysis of the ego-networks falling closest to the center of clusters of users with similar conditional triad censuses suggested the presence of users on Facebook that exclusively manage disconnect social circles or participate in a highly collaborative singular one. It also found how content posted on Wikipedia may attract either the attention of a number of domain experts, or of multiple generalist editors. The data-driven approach was motivated by a comparative analysis of the existing equivalence based, implied, and data-driven role discovery methods that had been proposed. It concluded by suggesting the integration of social theories to derive features for role mining, and approaches to link together the notion of what a user can do on a social system with her social role on it. Future work should explore these opportunities, and may also consider unsupervised learners that allow users to fall into multiple role assignments. It is hoped that this important topic will continue to gain more attention in the computational social network analysis and mining community. References [1] N. K. Ahmed, J. Neville, and R. Kompella. Network sampling: from static to streaming graphs. arXiv preprint arXiv:1211.3412, 2012. [2] A. S. Alderson and J. Beckfield. Power and position in the world city system1. American Journal of sociology, 109(4):811–851, 2004. 25 [3] B. Baresch, L. Knight, D. Harp, and C. Yaschur. Friends who choose your news: An analysis of content links on facebook. In The Official Research Journal of International Symposium on Online Journalism, volume 1, pages 1–24, 2011. [4] L. Barkhuus and J. Tashiro. Student socialization in the age of facebook. In Proc. ofthe SIGCHI Conference on Human Factors in Computing Systems, pages 133–142. ACM, 2010. [5] V. Batagelj and A. Mrvar. A subquadratic triad census algorithm for large sparse networks with maximum degree. Social Networks, 23(3):237–243, 2001. [6] B. Batjargal. Network triads: transitivity, referral and venture capital decisions in china and russia. Journal of International Business Studies, 38(6):998–1012, 2007. [7] A. Baum, A. Shapiro, D. Murray, and M. V. Wideman. Interpersonal Mediation of Perceived Crowding and Control in Residential Dyads and Triads. Journal of Applied Social Phychology, 9(6):491–504, 1979. [8] S. P. Borgatti and M. G. Everett. The class of all regular equivalences: Algebraic structure and computation. Social Networks, 11(1):65–88, 1989. [9] S. P. Borgatti and M. G. Everett. Notions of position in social network analysis. Sociological methodology, 22(1):1–35, 1992. [10] S. P. Borgatti and M. G. Everett. Regular blockmodels of multiway, multimode matrices. Social Networks, 14(1):91–120, 1992. [11] S. P. Borgatti and M. G. Everett. Two algorithms for computing regular equivalence. Social Networks, 15(4):361–376, 1993. [12] T. E. Bosch. Using online social networking for teaching and learning: Facebook use at the university of cape town. Communicatio: South African Journal for Communication Theory and Research, 35(2):185– 200, 2009. [13] D. Brass, K. Butterfield, and B. Skaggs. Relationships and Unethical Behavior: A Social Network Perspec- tive. The Academy of Management Review, 23(1):14–31, 1998. [14] M. Burke and R. Kraut. Using facebook after losing a job: Differential benefits of strong and weak ties. In Proc. of the ACM Conference on Computer Supported Cooperative Work, pages 1419–1430. ACM, 2013. [15] R. S. Burt. Detecting role equivalence. Social Networks, 12(1):83–97, 1990. 26 [16] E. Cambria, D. Rajagopal, D. Olsher, and D. Das. Big social data analysis. Big data computing, pages 401–414, 2013. [17] T. Caplow. Two against one: Coalitions in triads. Prentice-Hall Englewood Cliffs, NJ, 1968. [18] J. Chan, C. Hayes, and E. M. Daly. Decomposing discussion forums and boards using user roles. In Intl. Conference on Weblogs and Social Media, volume 10, pages 215–218, 2010. [19] W. Chen, Y. Wang, and S. Yang. Efficient influence maximization in social networks. In Proc. of 15th ACM SIGKDD Intl. Conference on Knowledge discovery and data mining, pages 199–208. ACM, 2009. [20] W. Chen, Y. Yuan, and L. Zhang. Scalable influence maximization in social neworks under the linear threshold model. In Proc. of 10th IEEE Intl. Conference on Data Mining, 2010. [21] A. Clauset, C. R. Shalizi, and M. Newman. Power-Law Distributions in Empirical Data. Technical report, arXiv:0706.1062v2 [physics.data-an], 2009. [22] K. S. Cook and R. M. Emerson. Power, equity and commitment in exchange networks. American Socio- logical Review, pages 721–739, 1978. [23] K. S. Cook, R. M. Emerson, M. R. Gillmore, and T. Yamagishi. The distribution of power in exchange networks: Theory and experimental results. American journal of sociology, pages 275–305, 1983. [24] J. Davis and S. Leinhardt. The Structure of Positive Interpersonal Relations in Small Groups. Sociological Theories in Progress, 2:218–251, 197. [25] P. DiMaggio. Structural analysis of organizational fields: A blockmodel approach. Research in organiza- tional behavior, 8:335–370, 1986. [26] J. M. DiMicco and D. R. Millen. Identity management: multiple presentations of self in facebook. In Proc. of ACM Intl. Conference on Supporting Group Work, pages 383–386. ACM, 2007. [27] D. Doran. Triad-based Role Discovery for Large Social Systems. In Proc. of Intl. Conference on Social Informatics Workshops, LNCS 8852, pages 130–143, 2014. [28] D. Doran, H. Alhazmi, and S. Gokhale. Triads, Transitivity, and Social Effects in User Interactions on Facebook. In Proc. of IEEE Intl. Conference on Computational Aspects of Social Networks, pages 68–73, 2013. 27 [29] S. N. Dorogovtsev, A. V. Goltsev, and J. F. F. Mendes. K-core organization of complex networks. Physical review letters, 96(4):040601, 2006. [30] B. H. Erickson. The relational basis of attitudes. Social structures: A network approach, 99:121, 1988. [31] G. Fagiolo. Clustering in complex directed networks. Physical Review E, 76(2):026107, 2007. [32] T.-F. Fan and C.-J. Liau. Many-valued modal logic and regular equivalences in weighted social networks. In Symbolic and Quantitative Approaches to Reasoning with Uncertainty, pages 194–205. Springer, 2013. [33] K. Faust. Triadic configurations in limited choice sociometric networks: Empirical and theoretical results. Social Networks, pages 273–282, 2008. [34] S. Field, K. A. Frank, K. Schiller, C. Riegle-Crumb, and C. Muller. Identifying positions from affiliation networks: Preserving the duality of people and events. Social Networks, 28(2):97–123, 2006. [35] N. E. Friedkin and E. C. Johnsen. Social positions in influence networks. Social Networks, 19(3):209–222, 1997. [36] K. Fujimoto and T. W. Valente. Social network influences on adolescent substance use: Disentangling structural equivalence from cohesion. Social Science & Medicine, 74(12):1952–1960, 2012. [37] A. P. Gasch and M. B. Eisen. Exploring the conditional coregulation of yeast gene expression through fuzzy k-means clustering. Genome Biol, 3(11), October 2002. [38] G. B. Giannakis, F. Bach, R. Cendrillon, M. Mahoney, and J. Neville. Signal processing for big data, 2014. [39] E. Gleave, H. T. Welser, T. M. Lento, and M. A. Smith. A conceptual and operational definition of'social role'in online community. In 42nd Hawaii International Conference on System Sciences, pages 1–11, 2009. [40] B. Gliwa, A. Zygmunt, and J. Ko´zlak. Analysis of roles and groups in blogosphere. In Proc. of the 8th Intl. Conference on Computer Recognition Systems, pages 299–308, 2013. [41] S. A. Golder and J. Donath. Social roles in electronic communities. Internet Research, 5:19–22, 2004. [42] M. C. Gonz´alez, H. J. Herrmann, J. Kert´esz, and T. Vicsek. Community structure and ethnic preferences in school friendship networks. Physica A: Statistical mechanics and its applications, 379(1):307–316, 2007. [43] R. A. Hanneman and M. Riddle. Introduction to social network methods, 2005. 28 [44] J. Hautz, K. Hutter, J. Fuller, K. Matzler, and M. Rieger. How to establish an online innovation community? the role of users and their innovative content. In Hawaii Intl. Conference on System Sciences, pages 1–11, 2010. [45] X. He, H. Zha, C. H. Ding, and H. D. Simon. Web document clustering using hyperlink structures. Com- putational Statistics & Data Analysis, 41(1):19–45, 2002. [46] P. Holland and S. Leinhardt. An Omnibus Test for Social Structure Using Triads. Sociological Methods and Research, 7:227–256, 1978. [47] J. E. Jackson. A User's Guide to Principal Components. John Wiley & Sons, 2004. [48] M. Jamali and H. Abolhassani. Different aspects of social network analysis. In Intl. Conference on Web Intelligence, pages 66–72. IEEE, 2006. [49] R. Jin, V. E. Lee, and H. Hong. Axiomatic ranking of network role similarity. In Proc. of Intl. Conference on Knowledge Discovery and Data Mining, pages 922–930. ACM, 2011. [50] M. Jung and M. Choi. A mechanism of institutional isomorphism in referral networks among hospitals in seoul, south korea. The health care manager, 29(2):133–146, 2010. [51] D. Kempe, J. Kleinberg, and E. Tardos. Maximizing the spred of influence through a social network. In Proc. of 9th ACM Intl. Conference on Knowledge Discovery and Data Mining, pages 137–146, 2003. [52] S. Khot. Improved inapproximability results for maxclique, chromatic number and approximate graph coloring. In Proc. of IEEE Syomposium on Foundations of Computer Science, pages 600–609, 2001. [53] E. L. Kick, L. A. McKinney, S. McDonald, and A. Jorgenson. A multiple-network analysis of the world system of nations, 1995–1999. Sage handbook of social network analysis. Thousand Oaks, CA: Sage Publications, pages 311–27, 2011. [54] R. Kumar, J. Novak, and A. Tomkins. Structure and evolution of online social networks. In Link mining: models, algorithms, and applications, pages 337–357. Springer, 2010. [55] H. Kwak, C. Lee, H. Park, and S. Moon. What is Twitter, a Social Network or a News Media? In Proc. of 19th Intl. World Wide Web Conference, pages 591–600, 2010. [56] V. Labatut and J.-M. Balasque. Detection and interpretation of communities in complex networks: Practical methods and application. In Computational Social Networks, pages 81–113. Springer, 2012. 29 [57] A. Lampinen, S. Tamminen, and A. Oulasvirta. All my people right here, right now: management of group co-presence on a social networking site. In Proc. of ACM Intl. Conference on Supporting Group Work, pages 281–290. ACM, 2009. [58] D. Laniado, R. Tasso, Y. Volkovich, and A. Kaltenbrunner. When the wikipedians talk: Network and tree structure of wikipedia discussion pages. In Intl. Conference on Weblogs and Social Media, 2011. [59] J. Leskovec and C. Faloutsos. Sampling from Large Graphs. In Proc. of ACM Conference on Knowledge Discovery and Data Mining, 2006. [60] R. Li, S. Wang, H. Deng, R. Wang, and K. C.-C. Chang. Towards social user profiling: unified and discrim- inative influence model for inferring home locations. In Proc. of Intl. Conference on Knowledge discovery and data mining, pages 1023–1031. ACM, 2012. [61] L. Lipsky. Queueing Theory: A Linear Algebraic Approach. Springer-Verlag, 2nd edition, 2009. [62] F. Lorrain and H. C. White. Structural equivalence of individuals in social networks. The Journal of mathematical sociology, 1(1):49–80, 1971. [63] R. Malcolm, C. Morrison, T. Grandison, S. Thorpe, K. Christie, A. Wallace, D. Green, J. Jarrett, and A. Campbell. Increasing the accessibility to big data systems via a common services api. In IEEE Interna- tional Conference on Big Data, pages 883–892. IEEE, 2014. [64] S. Maniu, T. Abdessalem, and B. Cautis. Casting a web of trust over wikipedia: an interaction-based approach. In Proceedings of the 20th international conference companion on World wide web, pages 87– 88. ACM, 2011. [65] F. T. McAndrew and H. S. Jeong. Who does what on facebook? age, sex, and relationship status as predictors of facebook use. Computers in Human Behavior, 28(6):2359–2365, 2012. [66] O. Medelyan, I. H. Witten, and D. Milne. Topic indexing with wikipedia. In Proceedings of the AAAI WikiAI workshop, pages 19–24, 2008. [67] A. Mislove, M. Marcon, K. Gummadi, P. Druschel, and B. Bhattacharjee. Measurement and Analysis of Online Social Networks. In Proc. of the ACM Internet Measurement Conference, 2007. [68] J. Moody. Matrix methods for calculating the triad census. Social Networks, pages 291–299, 1998. 30 [69] D. Morselli, D. Spini, and T. Devos. Human values and trust in institutions across countries: A multilevel test of schwartzs hypothesis of structural equivalence. Survey Research Methods, 6(1):49–60, 2012. [70] M. Newman. Networks: an introduction. Oxford University Press, 2010. [71] R. D. Nolker and L. Zhou. Social computing and weighting to identify member roles in online communities. In Web Intelligence, 2005. Proceedings. The 2005 IEEE/WIC/ACM International Conference on, pages 87– 93, 2005. [72] T. Opsahl and P. Panzarasa. Clustering in weighted networks. Social networks, 31(2):155–163, 2009. [73] F. Pallotti and A. Lomi. Network influence and organizational performance: The effects of tie strength and structural equivalence. European Management Journal, 29(5):389–403, 2011. [74] T. A. Pempek, Y. A. Yermolayeva, and S. L. Calvert. College students' social networking experiences on facebook. Journal of Applied Developmental Psychology, 30(3):227–238, 2009. [75] S. M. Radil, C. Flint, and G. E. Tita. Spatializing social networks: Using social network analysis to inves- tigate geographies of gang rivalry, territoriality, and violence in los angeles. Annals of the Association of American Geographers, 100(2):307–326, 2010. [76] R. B. Rothenberg, J. J. Potterat, D. E. Woodhouse, S. Q. Muth, W. W. Darrow, and A. S. Klovdahl. Social network dynamics and hiv transmission. Aids, 12(12):1529–1536, 1998. [77] M. Rowe, M. Fernandez, S. Angeletou, and H. Alani. Community analysis through semantic rules and role composition derivation. Web Semantics: Science, Services and Agents on the World Wide Web, 18(1):31–47, 2013. [78] J. Scott and P. J. Carrington. The SAGE handbook of social network analysis. SAGE publications, 2011. [79] G. Simmel and K. H. Wolff. The Sociology of Georg Simmel. Macmillan Publishing Co., 1950. [80] J. B. Singer. User-generated visibility: Secondary gatekeeping in a shared media space. New Media & Society, 16(1):55–73, 2014. [81] M. M. Skeels and J. Grudin. When social networks cross boundaries: a case study of workplace use of facebook and linkedin. In Proc. of ACM Intl. Conference on Supporting Group Work, pages 95–104. ACM, 2009. 31 [82] D. A. Smith and D. R. White. Structure and dynamics of the global economy: Network analysis of interna- tional trade 1965-1980. Social Forces, 70(4):857–893, 1992. [83] P.-N. Tan, M. Steinbach, and V. Kumar. Introduction to Data Mining. Addison-Wesley, 2006. [84] J. Tang, J. Sun, C. Wang, and Z. Yang. Social influence analysis in large-scale networks. In Proc. of ACM SIGKDD international conference on Knowledge discovery and data mining, pages 807–816. ACM, 2009. [85] A. Tselykh and G. Veselov. Positional analysis and mapping of scientific networks. World Applied Sciences Journal, 27(12):1625–1629, 2013. [86] J. Ugander, B. Karrer, L. Backstrom, and C. Marlow. The Anatomy of the Facebook Social Graph. Technical report, arXiv:1111.4503v1 [cs.SI], 2001. [87] B. Viswanath, A. Mislove, M. Cha, and K. Gummadi. On the Evolution of User Interaction in Facebook. In Proc. of 2nd ACM Workshop on Online Social Networks, 2009. [88] H. T. Vu. The online audience as gatekeeper: The influence of reader metrics on news editorial selection. Journalism, 15(8):1094–1110, 2014. [89] S. Wasserman and K. Faust. Social network analysis: Methods and applications, volume 8. Cambridge university press, 1994. [90] S. S. Wasserman. Random Directed Graph Distrbutions and the Triad Census in Social Networks. Journal of Mathematical Sociology, 5:61–86, 1977. [91] B. Wellman. Structural analysis: From method and metaphor to theory and substance. Contemporary Studies in Sociology, 15:19–61, 1997. [92] H. T. Welser, D. Cosley, G. Kossinets, A. Lin, F. Dokshin, G. Gay, and M. Smith. Finding social roles in wikipedia. In Proc. of ACM iConference, pages 122–129, 2011. [93] A. J. White, J. Chan, C. Hayes, and B. Murphy. Mixed membership models for exploring user roles in online fora. In Intl. Conference on Weblogs and Social Media, 2012. [94] H. C. White. Varieties of markets. Contemporary Studies in Sociology, 15:226–260, 1997. [95] H. C. White, S. A. Boorman, and R. L. Breiger. Social structure from multiple networks. i. blockmodels of roles and positions. American journal of sociology, pages 730–780, 1976. 32 [96] C. Wilson, B. Boe, A. Sala, K. P. Puttaswamy, and B. Y. Zhao. User interactions in social networks and their implications. In Proceedings of the 4th ACM European conference on Computer systems, pages 205–218. ACM, 2009. [97] C. Wilson, A. Sala, K. P. Puttaswamy, and B. Y. Zhao. Beyond social graphs: User interactions in online social networks and their implications. ACM Transactions on the Web, 6(4):17, 2012. [98] A. Zaheer and G. G. Bell. Benefiting from network position: firm capabilities, structural holes, and perfor- mance. Strategic management journal, 26(9):809–825, 2005. [99] Y. Zhang, M. Chen, S. Mao, L. Hu, and V. C. Leung. Cap: community activity prediction based on big data analysis. IEEE Network, 28(4):52–57, 2014. [100] D. Zhong and H. Zhang. Clustering methods for video browsing and annotation. Technical report, In SPIE Conference on Storage and Retrieval for Image and Video Databases, 1997. [101] M. Zhou and C.-u. Park. The cohesion effect of structural equivalence on global bilateral trade, 1948–2000. International Sociology, 27(4):502–523, 2012. [102] T. Zhu, B. Wang, B. Wu, and C. Zhu. Role defining using behavior-based clustering in telecommunication network. Expert Systems with Applications, 38(4):3902–3908, 2011. 33
1912.08926
1
1912
2019-11-25T03:55:55
Rumor Detection and Classification for Twitter Data
[ "cs.SI", "cs.LG", "stat.ML" ]
With the pervasiveness of online media data as a source of information verifying the validity of this information is becoming even more important yet quite challenging. Rumors spread a large quantity of misinformation on microblogs. In this study we address two common issues within the context of microblog social media. First we detect rumors as a type of misinformation propagation and next we go beyond detection to perform the task of rumor classification. WE explore the problem using a standard data set. We devise novel features and study their impact on the task. We experiment with various levels of preprocessing as a precursor of the classification as well as grouping of features. We achieve and f-measure of over 0.82 in RDC task in mixed rumors data set and 84 percent in a single rumor data set using a two-step classification approach.
cs.SI
cs
Rumor Detection and Classification for Twitter Data Sardar Hamidian and Mona Diab Department of Computer Science The George Washington University Washington DC, USA Email: [email protected], [email protected] Abstract -- With(cid:1)the(cid:1)pervasiveness(cid:1)of(cid:1)online(cid:1)media(cid:1)data(cid:1)as(cid:1)a(cid:1) source(cid:1)of(cid:1)information,(cid:1)verifying(cid:1)the(cid:1)validity(cid:1)of(cid:1)this(cid:1)informa- tion(cid:1)is(cid:1)becoming(cid:1)even(cid:1)more(cid:1)important(cid:1)yet(cid:1)quite(cid:1)challenging.(cid:1) Rumors(cid:1) spread(cid:1) a(cid:1) large(cid:1) quantity(cid:1) of(cid:1) misinformation(cid:1) on(cid:1) microblogs.(cid:1) In(cid:1) this(cid:1) study(cid:1) we(cid:1) address(cid:1) two(cid:1) common(cid:1) issues(cid:1) within(cid:1) the(cid:1) context(cid:1) of(cid:1) microblog(cid:1) social(cid:1) media.(cid:1) First,(cid:1) we(cid:1) detect(cid:1) rumors(cid:1) as(cid:1) a(cid:1) type(cid:1) of(cid:1) misinformation(cid:1) propagation,(cid:1) and(cid:1) next,(cid:1) we(cid:1) go(cid:1) beyond(cid:1) detection(cid:1) to(cid:1) perform(cid:1) the(cid:1) task(cid:1) of(cid:1) rumor(cid:1)classification(cid:1)(RDC).(cid:1)We(cid:1)explore(cid:1)the(cid:1)problem(cid:1)using(cid:1) a(cid:1) standard(cid:1) data(cid:1) set.(cid:1) We(cid:1) devise(cid:1) novel(cid:1) features(cid:1) and(cid:1) study(cid:1) their(cid:1)impact(cid:1)on(cid:1)the(cid:1)task.(cid:1)We(cid:1)experiment(cid:1)with(cid:1)various(cid:1)levels(cid:1) of(cid:1)preprocessing(cid:1)as(cid:1)a(cid:1)precursor(cid:1)to(cid:1)the(cid:1)classification(cid:1)as(cid:1)well(cid:1) as(cid:1)grouping(cid:1)of(cid:1)features.(cid:1)We(cid:1)achieve(cid:1)an(cid:1)F-Measure(cid:1)of(cid:1)over(cid:1) 0.82(cid:1)in(cid:1)the(cid:1)RDC(cid:1)task(cid:1)in(cid:1)a(cid:1)mixed(cid:1)rumors(cid:1)data(cid:1)set(cid:1)and(cid:1)84% in(cid:1) a(cid:1) single(cid:1) rumor(cid:1) data(cid:1) set(cid:1) using(cid:1) a(cid:1) two(cid:1) step(cid:1) classification(cid:1) approach. Keywords -- Rumor(cid:1) Detection(cid:1) and(cid:1) Classification;(cid:1) Super- vised(cid:1) Machine(cid:1) Learning;(cid:1) Feature-based(cid:1) model. I.(cid:1) INTRODUCTION Social(cid:1) media(cid:1) is(cid:1) currently(cid:1) a(cid:1) place(cid:1) where(cid:1) massive(cid:1) data(cid:1) is(cid:1) generated(cid:1) continuously.(cid:1) Nowadays,(cid:1) novel(cid:1) break- ing(cid:1) news(cid:1) appear(cid:1) first(cid:1) on(cid:1) microblogs,(cid:1) before(cid:1) making(cid:1) it(cid:1) through(cid:1) to(cid:1) traditional(cid:1) media(cid:1) outlets.(cid:1) Hence,(cid:1) microblog- ging(cid:1) websites(cid:1) are(cid:1) rich(cid:1) sources(cid:1) of(cid:1) information(cid:1) which(cid:1) have(cid:1) been(cid:1) successfully(cid:1) leveraged(cid:1) for(cid:1) the(cid:1) analysis(cid:1) of(cid:1) sociopragmatic(cid:1)phenomena,(cid:1)such(cid:1)as(cid:1)belief,(cid:1)opinion,(cid:1)and(cid:1) sentiment(cid:1) in(cid:1) online(cid:1) communication.(cid:1) Twitter(cid:1) [27](cid:1) is(cid:1) one(cid:1) of(cid:1) the(cid:1) most(cid:1) popular(cid:1) microblogging(cid:1) platforms.(cid:1) It(cid:1) serves(cid:1) as(cid:1) one(cid:1) of(cid:1) the(cid:1) foremost(cid:1) goto(cid:1) media(cid:1) for(cid:1) research(cid:1) in(cid:1) natu- ral(cid:1) language(cid:1) processing(cid:1) (NLP),(cid:1) where(cid:1) practitioners(cid:1) rely(cid:1) on(cid:1) deriving(cid:1) various(cid:1) sets(cid:1) of(cid:1) features(cid:1) leveraging(cid:1) content,(cid:1) network(cid:1) structure,(cid:1) and(cid:1) memes(cid:1) of(cid:1) users(cid:1) within(cid:1) these(cid:1) networks.(cid:1)However,(cid:1)the(cid:1)unprecedented(cid:1)existence(cid:1)of(cid:1)such(cid:1) massive(cid:1)data(cid:1)acts(cid:1)as(cid:1)a(cid:1)double(cid:1)edged(cid:1)sword,(cid:1)one(cid:1)can(cid:1)easily(cid:1) get(cid:1)unreliable(cid:1)information(cid:1)from(cid:1)such(cid:1)sources,(cid:1)and(cid:1)it(cid:1)is(cid:1)a(cid:1) challenge(cid:1)to(cid:1)control(cid:1)the(cid:1)spread(cid:1)of(cid:1)false(cid:1)information(cid:1)either(cid:1) maliciously(cid:1)or(cid:1)even(cid:1)inadvertently.(cid:1)The(cid:1)information(cid:1)seeker(cid:1) is(cid:1) inundated(cid:1) with(cid:1) an(cid:1) influx(cid:1) of(cid:1) data.(cid:1) Most(cid:1) importantly,(cid:1) it(cid:1) is(cid:1) hard(cid:1) to(cid:1) distinguish(cid:1) reliable(cid:1) information(cid:1) from(cid:1) false(cid:1) information,(cid:1)especially(cid:1)if(cid:1)the(cid:1)data(cid:1)appears(cid:1)to(cid:1)be(cid:1)formatted and well structured [9] [24]. The problem is exacerbated by the fact that many information seekers believe that anything online in digital form is true and that the information is accurate and trustworthy; although, it is well known that a lot of the information on the web could be false or untrue. This is especially crucial in cases of emergencies. For example, by simply hitting the Re-tweet button on Twitter, within a fraction of a second, a piece of information becomes viral almost instantly. There are widely varying definitions of the term "rumor". We adopt the following definition of rumor: a rumor could be both true or false. A rumor is a claim whose truthfulness is in doubt and has no clear source, even if its ideological or partisan origins and intents are clear [2]. In verifying the accuracy of claims or events online, there are four major aspects that could be checked: Provenance, the original piece of content; Source, who uploaded the content; Date-and-location, when and where the content was created [22]. Analyzing each of these items individually plays a key role in verifying the trustworthiness of the data. In this paper, we address the problem of detecting rumors in Twitter data. We start with the motivation behind this research, and then the history of different studies about rumors is overviewed in Section 2. Next, in Section 3, the overall pipeline is exposed, in which we adopt a supervised machine learning framework with several feature sets, and finally in Section 4, we compare our results to the current state of the art performance on the task. We show that our approach yields comparable and even superior results to the work to date. II. RELATED WORK Psychologists studied the phenomenon of rumors from various angles. First studies were carried out in 1902 by German psychologist and philosopher, William Stern, and later in 1947 by his student Gordon Allport, who studied how stories get affected in their lifecy- cle [10]. In 1994, Robert Knapp published "A Psychol- ogy(cid:1)of(cid:1)Rumors",(cid:1)which(cid:1)comprised(cid:1)of(cid:1)a(cid:1)collection(cid:1)of(cid:1)more(cid:1) than(cid:1)a(cid:1)thousand(cid:1)rumors(cid:1)propagated(cid:1)during(cid:1)World(cid:1)War(cid:1)II.(cid:1) In(cid:1)his(cid:1)work,(cid:1)the(cid:1)rumor(cid:1)is(cid:1)what(cid:1)was(cid:1)transmitted(cid:1)by(cid:1)word(cid:1) of(cid:1)mouth(cid:1)and(cid:1)bore(cid:1)information(cid:1)about(cid:1)a(cid:1)person,(cid:1)an(cid:1)event,(cid:1) or(cid:1) a(cid:1) condition,(cid:1) which(cid:1) fulfilled(cid:1) the(cid:1) emotional(cid:1) desires(cid:1) of(cid:1) the(cid:1) public(cid:1) [11].(cid:1) In(cid:1) 1948,(cid:1) Allport(cid:1) and(cid:1) Postman(cid:1) [12](cid:1) studied(cid:1) the(cid:1) behavior(cid:1) of(cid:1) rumors(cid:1) and(cid:1) how(cid:1) one(cid:1) rumor(cid:1) reflects(cid:1) leveling,(cid:1) sharpening,(cid:1) and(cid:1) assimilation(cid:1) behavior(cid:1) in(cid:1)its(cid:1)propagation.(cid:1)Related(cid:1)studies(cid:1)in(cid:1)political(cid:1)communi- cation(cid:1)conducted(cid:1)by(cid:1)Harsin(cid:1)[2](cid:1)presented(cid:1)the(cid:1)idea(cid:1)of(cid:1)the(cid:1) "Rumor(cid:1) Bomb".(cid:1) For(cid:1) Harsin,(cid:1) a(cid:1) "Rumor(cid:1) Bomb"(cid:1) spreads(cid:1) the(cid:1) notion(cid:1) of(cid:1) the(cid:1) rumor(cid:1) into(cid:1) a(cid:1) political(cid:1) communication(cid:1) concept.(cid:1)In(cid:1)other(cid:1)research,(cid:1)Kumar(cid:1)and(cid:1)Geethakumari(cid:1)[5](cid:1) explore(cid:1) the(cid:1) use(cid:1) of(cid:1) theories(cid:1) in(cid:1) cognitive(cid:1) psychology(cid:1) to(cid:1) estimate(cid:1) the(cid:1) spread(cid:1) of(cid:1) disinformation,(cid:1) misinformation,(cid:1) and(cid:1) propaganda(cid:1) across(cid:1) social(cid:1) networks.(cid:1) There(cid:1) are(cid:1) sev- eral(cid:1) studies(cid:1) about(cid:1) the(cid:1) behavior(cid:1) of(cid:1) misinformation(cid:1) and(cid:1) how(cid:1)they(cid:1)are(cid:1)distinguished(cid:1)in(cid:1)a(cid:1)microblog(cid:1)network.(cid:1)For(cid:1) example,(cid:1)Budak(cid:1)took(cid:1)a(cid:1)step(cid:1)further(cid:1)[4](cid:1)investigating(cid:1)how(cid:1) to(cid:1)overcome(cid:1)the(cid:1)spread(cid:1)of(cid:1)misinformation(cid:1)by(cid:1)applying(cid:1)an(cid:1) optimized(cid:1)limitation(cid:1)campaign(cid:1)to(cid:1)counteract(cid:1)the(cid:1)effect(cid:1)of(cid:1) misinformation. From(cid:1) an(cid:1) NLP(cid:1) perspective,(cid:1) researchers(cid:1) have(cid:1) studied(cid:1) numerous(cid:1) aspects(cid:1) of(cid:1) credibility(cid:1) of(cid:1) online(cid:1) information.(cid:1) For(cid:1) example,(cid:1) Ghaoui(cid:1) [3](cid:1) detects(cid:1) rumors(cid:1) within(cid:1) spe- cialized(cid:1) domains,(cid:1) such(cid:1) as(cid:1) trustworthiness,(cid:1) credibility(cid:1) assessment(cid:1) and(cid:1) information(cid:1) verification(cid:1) in(cid:1) online(cid:1) com- munication.(cid:1)Modeling(cid:1)and(cid:1)monitoring(cid:1)the(cid:1)social(cid:1)network(cid:1) as(cid:1) a(cid:1) connected(cid:1) graph(cid:1) is(cid:1) another(cid:1) approach.(cid:1) Seo(cid:1) [6](cid:1) identifies(cid:1) rumors(cid:1) and(cid:1) their(cid:1) corresponding(cid:1) sources(cid:1) by(cid:1) observing(cid:1) which(cid:1) of(cid:1) the(cid:1) monitoring(cid:1) nodes(cid:1) receive(cid:1) the(cid:1) given(cid:1) information(cid:1) and(cid:1) which(cid:1) do(cid:1) not.(cid:1) Another(cid:1) relevant(cid:1) work,(cid:1)Castillo(cid:1)[23],(cid:1)applied(cid:1)the(cid:1)time-sensitive(cid:1)supervised(cid:1) approach(cid:1)by(cid:1)relying(cid:1)on(cid:1)the(cid:1)tweet(cid:1)content(cid:1)to(cid:1)address(cid:1)the(cid:1) credibility(cid:1) of(cid:1) a(cid:1) tweet(cid:1) in(cid:1) different(cid:1) situations.(cid:1) The(cid:1) most(cid:1) relevant(cid:1)related(cid:1)work(cid:1)to(cid:1)ours(cid:1)is(cid:1)that(cid:1)reported(cid:1)in(cid:1)[1],(cid:1)which(cid:1) addresses(cid:1)rumor(cid:1)detection(cid:1)in(cid:1)Twitter(cid:1)using(cid:1)content-based(cid:1) as(cid:1) well(cid:1) as(cid:1) microblog-specific(cid:1) meme(cid:1) features.(cid:1) However,(cid:1) differences(cid:1) in(cid:1) data(cid:1) set(cid:1) size(cid:1) and(cid:1) number(cid:1) of(cid:1) classes(cid:1) (ru- mor(cid:1) types)(cid:1) render(cid:1) their(cid:1) results(cid:1) not(cid:1) comparable(cid:1) to(cid:1) ours.(cid:1) Moreover,(cid:1) Qazvinian(cid:1) et(cid:1) al.(cid:1) [1](cid:1) suggest(cid:1) label-dependent(cid:1) features(cid:1) in(cid:1) creating(cid:1) their(cid:1) User-based(cid:1) (USR)(cid:1) and(cid:1) URL(cid:1) features,(cid:1)which(cid:1)is(cid:1)only(cid:1)possible(cid:1)by(cid:1)having(cid:1)the(cid:1)input(cid:1)data(cid:1) labeled(cid:1)for(cid:1)being(cid:1)a(cid:1)rumor(cid:1)or(cid:1)not.(cid:1)In(cid:1)other(cid:1)words,(cid:1)labeled(cid:1) data(cid:1)is(cid:1)used(cid:1)for(cid:1)creating(cid:1)the(cid:1)language(cid:1)model(cid:1)(LM)(cid:1)with(cid:1) USR(cid:1)and(cid:1)URL(cid:1)features,(cid:1)and(cid:1)the(cid:1)trained(cid:1)LM(cid:1)is(cid:1)then(cid:1)used(cid:1) for(cid:1)extracting(cid:1)the(cid:1)value(cid:1)of(cid:1)each(cid:1)feature.(cid:1)In(cid:1)our(cid:1)study,(cid:1)we(cid:1) propose(cid:1) a(cid:1) totally(cid:1) label-independent(cid:1) method(cid:1) for(cid:1) feature(cid:1) generation(cid:1) that(cid:1) relies(cid:1) on(cid:1) the(cid:1) tweet(cid:1) content,(cid:1) and(cid:1) boosts TABLE I. LIST OF ANNOTATED RUMORS [1] Rumor Obama Michele Michelle Obama hired many staff Rumor Reference Is Barack Obama muslim? members? Cellphone Cell phone numbers going public? Palin AirFrance Air France mid-air crash photos? Sarah Palin getting divorced? # of tweets 4975 299 215 4423 505 our model in a realtime environment. III. APPROACH We addressed the problem of rumor detection and classification (RDC) within the context of microblog social media. We focused our research on Twitter data due to the availability of annotated data in this genre, in addition to the above mentioned interesting character- istics of microblogging, and their specific relevance to rumor proliferation. A. Data Qazvinian et al. [1] published an annotated Twitter data set for five different 'established' rumors as listed in Table I. The general annotation guidelines are presented in Table II. TABLE II. RUMOR DETECTION ANNOTATION GUIDELINES 0 11 12 13 14 2 If the tweet is not about the rumor If the tweet endorses the rumor If the tweet denies the rumor If the tweet questions the rumor If the tweet is neutral If the annotator is undetermined The following examples illustrate each of the anno- tation labels from the Obama rumor collection. 0: 2010-09-24 15:12:32 , nina1236 , Obama: Mus- lims 2019 Right To Build A Manhattan Mosque: While celebrating Ramadan with Muslims at the White House, Presi... http://bit.ly/c0J2aI 11: 2010-09-28 18:36:47 , Phanti , RT @IPlantSeeds: Obama Admits He Is A Muslim http://post.ly/10Sf7 - I thought he did that before he was elected. 12: 2010-10-01 05:00:28 , secksaddict , barack obama was raised a christian he attended a church with jeremiah wright yet people still beleive hes a muslim 13: 2010-10-09 06:54:18 , affiliateforce1 , Obama, Muslim Or Christian? (Part 3) http://goo.gl/fb/GJtsJ 14: 2010-09-28 22:22:40 , OTOOLEFAN , @JoeNBC The more Obama says he's a Christian, the more right wingers will say he's a Muslim." 2: 2010-10-05 17:37:04 , zolqarnain , Peaceful Serbia: Islam- Muslims http://wp.me/p121oH-1ir OBAMA SILENT #politics #AACONS #acon #alvedaking #women #news #tcot CHURCH in Burn Table III shows statistics for the annotated tweets corresponding to each of the five rumors. The original data set as obtained from [1] did not contain the actual tweets for both Obama and Cellphone rumors, but they only contained the tweet IDs. Hence, we used the Twitter API for downloading the specific tweets using the tweet ID. Accordingly, the size of our data set is different from that of [1] amounting to 9000 tweet in total for our experimentation. TABLE III. LIST OF ANNOTATED TWEETS PER LABEL PER RUMOR Rumor Obama Michelle Palin Cellphone Air France Mix 11 0 689 945 191 83 1709 86 65 92 306 71 1512 2725 12 410 24 1895 3 114 2452 B. Experimental Conditions 14 2 13 160 224 1232 1 0 639 94 3 3 14 0 817 321 1232 0 0 0 0 Total 3666 299 4423 166 505 9059 We(cid:1) approached(cid:1) RDC(cid:1) in(cid:1) a(cid:1) supervised(cid:1) manner(cid:1) and(cid:1) investigated(cid:1)the(cid:1)effectiveness(cid:1)of(cid:1)multi(cid:1)step(cid:1)classification(cid:1) with(cid:1) various(cid:1) sets(cid:1) of(cid:1) features(cid:1) and(cid:1) preprocessing(cid:1) tasks(cid:1) versus(cid:1)a(cid:1)single(cid:1)step(cid:1)detection(cid:1)and(cid:1)classification(cid:1)approach.(cid:1) In(cid:1) the(cid:1) single-step(cid:1) classification(cid:1) for(cid:1) RDC,(cid:1) we(cid:1) performed(cid:1) detection(cid:1) and(cid:1) classification(cid:1) simultaneously(cid:1) as(cid:1) a(cid:1) 6-way(cid:1) classification(cid:1) task(cid:1) among(cid:1) the(cid:1) six(cid:1) classes(cid:1) in(cid:1) the(cid:1) labeled(cid:1) data,(cid:1) as(cid:1) shown(cid:1) in(cid:1) Table(cid:1) II,(cid:1) by(cid:1) retrieving(cid:1) the(cid:1) tweets(cid:1) as(cid:1) Not(cid:1)Rumor(0),(cid:1)Endorses(cid:1)Rumor(11),(cid:1)Denies(cid:1)Rumor(12),(cid:1) Questions(cid:1) Rumor(13),(cid:1) Neutral(14),(cid:1) and(cid:1) Undetermined(cid:1) tweets(2).(cid:1)In(cid:1)the(cid:1)two-step(cid:1)classification(cid:1)set(cid:1)up,(cid:1)an(cid:1)initial(cid:1) 3-way(cid:1) classification(cid:1) task(cid:1) is(cid:1) performed(cid:1) among(cid:1) the(cid:1) fol- lowing(cid:1)groups(cid:1)of(cid:1)fine(cid:1)grained(cid:1)labels(cid:1)(0,(cid:1)Not(cid:1)Rumor),(cid:1)(2,(cid:1) Undetermined(cid:1)tweet),(cid:1)and(cid:1)the(cid:1)compound(cid:1)(11-14,(cid:1)Rumor)(cid:1) labels.(cid:1) This(cid:1) is(cid:1) followed(cid:1) by(cid:1) a(cid:1) 4-way(cid:1) classification(cid:1) step(cid:1) for(cid:1)the(cid:1)singleton(cid:1)labels,(cid:1)(11,(cid:1)Endorsing(cid:1)the(cid:1)Rumor),(cid:1)(12(cid:1) Denys(cid:1)the(cid:1)Rumor),(cid:1)(13,(cid:1)Questions(cid:1)the(cid:1)Rumor),(cid:1)and(cid:1)(14,(cid:1) Neutral(cid:1) about(cid:1) the(cid:1) Rumor).(cid:1) In(cid:1) the(cid:1) second(cid:1) step,(cid:1) we(cid:1) took(cid:1) out(cid:1) class(cid:1) 0(cid:1) and(cid:1) 2(cid:1) tweets(cid:1) from(cid:1) the(cid:1) training(cid:1) data(cid:1) set(cid:1) and(cid:1) only(cid:1) classified(cid:1) the(cid:1) tweets(cid:1) from(cid:1) the(cid:1) test(cid:1) data(cid:1) set,(cid:1) which(cid:1) had(cid:1) been(cid:1) classified(cid:1) as(cid:1) rumor(cid:1) in(cid:1) the(cid:1) first(cid:1) step.(cid:1) The(cid:1)underlying(cid:1)motivation(cid:1)of(cid:1)our(cid:1)effort(cid:1)in(cid:1)designing(cid:1)the(cid:1) single-step(cid:1) and(cid:1) two-step(cid:1) classification(cid:1) is(cid:1) to(cid:1) investigate(cid:1) the(cid:1)performance(cid:1)of(cid:1)each(cid:1)technique(cid:1)in(cid:1)order(cid:1)to(cid:1)solve(cid:1)two(cid:1) problems.(cid:1) First,(cid:1) classifying(cid:1) tweets(cid:1) as(cid:1) 'Rumor'(cid:1) and(cid:1) 'Not Rumor', which can assist users to distinguish the type of tweets. Second, classifying the rumor type that the tweet endorses, denies, questions or is neutral. Although in both problems we investigated the rumor, these two problems are different. Our two-step model pipeline is dynamic in a way that the output of the the first step (Rumor Detection) is the input data set for the next step (Rumor Type Classification). We also designed a new set of pragmatic features along with updating the set of features in Twitter and network-specific category, which could boost the overall performance in our pipeline. C. Machine Learning Frameworks For our experiment we applied J48, a discriminative classifier that utilizes decision trees and supports various types of attributes. WEKA platform [25] is used for training and testing the proposed models in our pipeline. TABLE IV. FINAL LIST OF USED FEATURES. '*' MARKED FEATURES ARE THE APPENDED SET OF FEATURES Twitter and Network Specific Content Pragmatic Value ID Binary * Time Binary * Hashtag String Hashtag Content Binary URL Binary Re-tweet Binary *Reply User ID Binary Content Unigram String String Content Bigram String Pos Unigram String Pos Bigram String *NER *Event String String *Sentiment *Emoticon Binary D. Feature Sets We experimented with content, network, and social meme features. We extended the number of features by including the pragmatic attributes. We employed all the features proposed in [1] in addition to developing more pragmatic attributes as well as additional network features. For network and meme features, we explicitly modeled source and timestamped information and for pragmatic features we proposed NER, Event, Sentiment, and Emoticon. Table IV lists all the features for the RDC task and marked the new features with "*". 1) Content Features: This set of features is developed using tweet content. We applied various preprocessing granularity levels to measure the impact of preprocessing on the RDC task. a)(cid:1)Unigram-Bigram(cid:1)Bag(cid:1)of(cid:1)Words(cid:1)(BOW):(cid:1) Similar(cid:1) to(cid:1) the(cid:1) content(cid:1) lexical(cid:1) features(cid:1) proposed(cid:1) in(cid:1) [1],(cid:1) we(cid:1) used(cid:1) a(cid:1) bag(cid:1) of(cid:1) words(cid:1) feature(cid:1) set(cid:1) comprising(cid:1) word(cid:1) unigrams(cid:1) and(cid:1)bigrams.(cid:1)We(cid:1)employed(cid:1)the(cid:1)WEKA's(cid:1)String(cid:1)To(cid:1)Word(cid:1) Vector(cid:1) along(cid:1) with(cid:1) N-gram(cid:1) tokenizer(cid:1) for(cid:1) creating(cid:1) this(cid:1) feature(cid:1) set(cid:1) with(cid:1) the(cid:1) TF-IDF(cid:1) weighting(cid:1) factor(cid:1) as(cid:1) the(cid:1) matrix(cid:1) cell(cid:1) content(cid:1) corresponding(cid:1) to(cid:1) each(cid:1) feature.(cid:1) We(cid:1) also(cid:1)generated(cid:1)the(cid:1)lemma(cid:1)form(cid:1)of(cid:1)the(cid:1)words(cid:1)in(cid:1)the(cid:1)tweets(cid:1) using(cid:1) WordNet(cid:1) [19](cid:1) lemmatization(cid:1) capability.(cid:1) Accord- ingly,(cid:1) we(cid:1) created(cid:1) four(cid:1) feature(cid:1) sets:(cid:1) unigram(cid:1) tokenized(cid:1) word(cid:1)form,(cid:1)unigram(cid:1)lemma(cid:1)form,(cid:1)bigram(cid:1)tokenized(cid:1)word(cid:1) form,(cid:1)and(cid:1)bigram(cid:1)lemma(cid:1)form. b)(cid:1)Part(cid:1) of(cid:1) Speech(cid:1) (POS):(cid:1) POS(cid:1) tagging(cid:1) for(cid:1) social(cid:1) media(cid:1) is(cid:1) challenging(cid:1) since(cid:1) the(cid:1) text(cid:1) genre(cid:1) is(cid:1) informal(cid:1) and(cid:1) quite(cid:1) noisy.(cid:1) We(cid:1) relied(cid:1) on(cid:1) the(cid:1) CMU(cid:1) Twitter(cid:1) POS(cid:1) tagger(cid:1)[7].(cid:1)The(cid:1)feature(cid:1)values(cid:1)are(cid:1)set(cid:1)to(cid:1)a(cid:1)binary(cid:1)0(cid:1)or(cid:1)1,(cid:1) corresponding(cid:1)to(cid:1)unseen(cid:1)or(cid:1)observed. 2)(cid:1)Pragmatic(cid:1) Features:(cid:1) In(cid:1) an(cid:1) extension(cid:1) to(cid:1) the(cid:1) fea- tures(cid:1) proposed(cid:1) by(cid:1) [1],(cid:1) we(cid:1) further(cid:1) explored(cid:1) the(cid:1) explicit(cid:1) modeling(cid:1) of(cid:1) pragmatic(cid:1) features(cid:1) to(cid:1) detect(cid:1) favorable(cid:1) and(cid:1) unfavorable(cid:1) opinions(cid:1) toward(cid:1) specific(cid:1) subjects(cid:1) (such(cid:1) as(cid:1) people,(cid:1) organizations).(cid:1) Applying(cid:1) this(cid:1) set(cid:1) of(cid:1) features(cid:1) offers(cid:1) enormous(cid:1) opportunities(cid:1) for(cid:1) detecting(cid:1) the(cid:1) type(cid:1) of(cid:1) rumors(cid:1)[21]. a)(cid:1)Sentiment:(cid:1) There(cid:1)are(cid:1)a(cid:1)wide(cid:1)variety(cid:1)of(cid:1)features(cid:1) for(cid:1)sentiment(cid:1)classification(cid:1)on(cid:1)Twitter(cid:1)data(cid:1)sets(cid:1)that(cid:1)have(cid:1) been(cid:1) studied(cid:1) in(cid:1) various(cid:1) publications.(cid:1) We(cid:1) believe(cid:1) that(cid:1) polarity(cid:1) of(cid:1) a(cid:1) tweet(cid:1) could(cid:1) be(cid:1) an(cid:1) informative(cid:1) factor(cid:1) to(cid:1) extract(cid:1)user's(cid:1)opinion(cid:1)about(cid:1)each(cid:1)rumor.(cid:1)For(cid:1)tagging(cid:1)the(cid:1) sentiment(cid:1) polarity(cid:1) of(cid:1) a(cid:1) tweet(cid:1) we(cid:1) applied(cid:1) the(cid:1) Stanford(cid:1) Sentiment(cid:1) system(cid:1) [18].(cid:1) We(cid:1) preprocessed(cid:1) the(cid:1) data(cid:1) by(cid:1) removing(cid:1)punctuations,(cid:1)URL,(cid:1)"RT",(cid:1)and(cid:1)lowercased(cid:1)the(cid:1) content.(cid:1)Each(cid:1)tweet(cid:1)is(cid:1)tagged(cid:1)with(cid:1)one(cid:1)of(cid:1)the(cid:1)following(cid:1) sentiment(cid:1) labels;(cid:1) Very(cid:1) Positive,(cid:1) Positive,(cid:1) Neutral,(cid:1) Neg- ative,(cid:1) or(cid:1) Very(cid:1) Negative. b)(cid:1)Emoticon:(cid:1) Another(cid:1)pragmatic(cid:1)cue(cid:1)is(cid:1)Emoticon.(cid:1) Studies(cid:1) on(cid:1) modeling(cid:1) and(cid:1) analyzing(cid:1) microblogs,(cid:1) which(cid:1) explicitly(cid:1)use(cid:1)emoticon(cid:1)as(cid:1)a(cid:1)feature,(cid:1)show(cid:1)its(cid:1)impact(cid:1)on(cid:1) classification(cid:1)[17].(cid:1)We(cid:1)used(cid:1)the(cid:1)list(cid:1)of(cid:1)popular(cid:1)emotions(cid:1) described(cid:1) in(cid:1) Wikipedia(cid:1) [26].(cid:1) We(cid:1) manually(cid:1) designated(cid:1) and(cid:1)labeled(cid:1)the(cid:1)list(cid:1)of(cid:1)entries(cid:1)as(cid:1)either(cid:1)expressing(cid:1)Positive(cid:1) (2),(cid:1)Negative(cid:1)(1),(cid:1)or(cid:1)Neutral(cid:1)(0)(cid:1)emotions. c)(cid:1)Named-Entity(cid:1) Recognition(cid:1) (NER):(cid:1) We(cid:1) em- ployed(cid:1)Twitter(cid:1)NLP(cid:1)tools(cid:1)[20](cid:1)to(cid:1)explicitly(cid:1)extract(cid:1)infor- mation(cid:1) about(cid:1) named-entities,(cid:1) such(cid:1) as(cid:1) Location,(cid:1) Person,(cid:1) Organization,(cid:1) etc.(cid:1) In(cid:1) this(cid:1) paper(cid:1) we(cid:1) show(cid:1) how(cid:1) modeling(cid:1) NER(cid:1)has(cid:1)an(cid:1)explicitly(cid:1)positive(cid:1)impact(cid:1)on(cid:1)performance. d)(cid:1)Event:(cid:1) Extracting(cid:1) the(cid:1) entity(cid:1) Obama(cid:1) and(cid:1) the(cid:1) event(cid:1)phrase(cid:1)praises(cid:1)in(cid:1)connection(cid:1)with(cid:1)Muslims(cid:1)is(cid:1)much more informative than simply extracting Obama. We utilized the same Twitter NLP tools [20] for tagging event labels. 3) Network and Twitter Specific Features: Relying on Twitter specific memes, we expanded features listed in [1] by adding time and network behavior features, such as Reply. a) Time: It is quite remarkable that social net- works spread news so fast. In a similar task to [13] we analyzed the process of rumor expansion on Twitter in our data set. Both the structure of social networks and the process that distributes the news lead to a piece of news becoming viral instantaneously. We labeled and ranked all the days based on the number of tweets posted in a day. We modeled the tweet creation-time attribute. We also observed that more than 90% of rumors are posted during the five most busiest days in the collected data set. Figure 1 shows the results of tabulating time frequency of the rumors in the Palin rumor data set and how the number of rumors changed within a six month period. Accordingly, we designated two labels for the time feature: Busy Day or Regular Day, depending on what type of day tweets were (re)tweeted. 16" 14" 12" 10" 8" 6" 4" 2" % e p y T % t e e w T 0" 17)May" 6)Jul" 25)Aug" 14)Oct" Tweet%Crated%Time% 3)Dec" 22)Jan" Figure 1. tweet Distribution for the Palin Rumor collection within a 6 month period b) Reply, Re-tweet, User ID: Replying and retweeting in microblogs are revealing factors in judging user's trustworthiness when it comes to relaying infor- mation [14]. For example, User A is more likely to post a rumor than User B if User A has a history of retweeting or replying to User C who also has a rumor spreading history. Investigating the credibility of users is an expensive and almost impossible task, but it is doable when we only want to investigate a specific story. For example, knowing the limited number of users who have TABLE V. NUMBER OF FEATURES AND LABELS USED IN SINGLE STEP AND TWO STEP CLASSIFICATIONS 1st Step Method (SRDC) 6-way classification (TRDC) 3-way (1st step) -- 4-way (2nd step) classification Labels (0)(11)(12)(13)(14)(2) (0)(2)(11-14) 2nd Step Labels (11)(12)(13)(14) a history of posting rumors could be a hint to detect the large number of users that follow, retweet or reply to those tweets. c) Hashtag: Hashtags serve as brief explanations of the tweet content [16]. We extracted hashtags in the labeled data set. Tweets with no hashtags are assigned a value 0 to their hashtag feature dimension, and tweets containing hashtag(s), received a 1 in the hashtag dimen- sion. Additionally, we added all the observed hashtags as feature dimensions, thereby effectively identifying the tweets that share the same hashtag. For compound hash- tags, we used a simple heuristic. If the hashtag contained an uppercase character in the middle of the hashtag word, then we split it before the uppercase letter. For instance, #SarahDivorce is separated into two hashtags and converted to Sarah and Divorce. We then modeled both compound and separated hashtags as hashtag feature dimensions. d) URL: Twitter users share URLs in their tweets to refer to external sources as an authentic proof (a source of grounding) to what they share. All URLs posted in tweets are shortened into 22 characters using the Twitter t.co service. Analyzing the URL is an expensive task and requires a huge source of information to verify the content of the shared URL. We excluded all URLs but we modeled their presence as a binary feature. IV. EXPERIMENTAL DESIGN All the experiments are designed, performed, and evaluated based on various experimental settings and conditions, all elaborated in this section. A. Data We experimented with three data sets: the two largest rumor sets, Obama and Palin, and a mixed data set (MIX) which comprises all the data from the five rumors. We splited each of the three data sets into 80% train, 10% development, and 10% test. B. Experimentation Platform All experimentations were carried out using the WEKA-3-6 platform [25]. C. Baselines We adopted two baselines: Majority and limiting the features to the set of features proposed in [1], which are Content, Hashtag-Content, URL, Re-tweet, and User ID. As the name indicates, the Majority baseline assigns the majority label from the training data set to all the test data. D. Experimental Conditions and Evaluation Metrics We had two main experimental conditions: single- step RDC (SRDC) and a two-step RDC (TRDC). We employed the set of 15 features listed in Table IV. Information about SRDC and TRDC is illustrated in Table V. In the development phase multiple settings and configurations were performed on the development data set for tuning, then the models that achieved the highest performance were used on the test set. Evaluating the performance of the proposed technique in rumor detection should rely upon both the number of relevant rumors that are selected (recall) and the number of selected rumors that are relevant (precision). Hence, we calculated F-measure, a harmonic mean of precision and recall due to its bias as an evaluation metric. TableVI shows the F-measure value for the different settings on the test set. V. RESULTS AND ANALYSIS In this section the impacts of different experimental conditions are investigated. A. SRDC and TRDC By studying the results in Table VI, it can be observed that TRDC significantly outperforms SRDC, since TRDC achieves an F measure of 82.9% compared to 74% in SRDC for the MIX data set, and 85.4% for the Obama data set compared to a 71.7% in SRDC. By comparing the F-Measure with the Majority baseline and the features proposed in [1](VAR11) as the second baseline, we could explicitly see how applying the proposed methodology and set of features enhances the overall performance in certain rumors, and also leads to acceptable performance in the MIX data set. TABLE VI. F-MEASURE RESULTS OF SRDC AND TRDC METHODS EMPLOYING 15 FEATURES AND VAR11 FEATURES data set MIX 1-3 Obama Palin Method Majority SRDC TRDC Majority SRDC TRDC Majority SRDC TRDC Our 15 Feat. 0.30 0.743 0.83 0.33 0.717 0.854 0.46 0.754 0.79 VAR11 Feat. 0.748 0.83 0.705 0.844 0.748 0.70 1" 0.9" 0.8" 0.7" 0.6" 0.5" 0.4" 0.3" 0.2" 0.1" 0" F=Measure" precision" Content" Pragma7c" Network" Figure 2. The Average F-measure and precision of SRDC and TRDC classifications employing each group of features: Content, Pragmatic, Network B. Impact of Feature Set In this experiment, we assessed the performance of different groups of features individually. Figure 2 shows the average F-measure and precision of SRDC and TRDC by employing the Content, Pragmatic and Network sets of features. As shown in Figure 2, employ- ing the Content set of features yields the overall best precision. In contrast to the other features, the network feature set had the minimum impact on our classification. C. Impact of Preprocessing As(cid:1) mentioned(cid:1) above,(cid:1) we(cid:1) applied(cid:1) various(cid:1) levels(cid:1) of(cid:1) preprocessing(cid:1)to(cid:1)the(cid:1)content(cid:1)of(cid:1)tweets(cid:1)such(cid:1)as(cid:1)stemming,(cid:1) lemmatization,(cid:1) punctuation(cid:1) removal,(cid:1) lowercasing,(cid:1) and(cid:1) stop(cid:1)words(cid:1)removal.(cid:1)We(cid:1)measured(cid:1)the(cid:1)impact(cid:1)of(cid:1)applying(cid:1) such(cid:1)preprocessing(cid:1)versus(cid:1)no(cid:1)preprocessing.(cid:1)Figure(cid:1)3(cid:1)il- lustrates(cid:1)that(cid:1)accuracy(cid:1)doesn't(cid:1)benefit(cid:1)from(cid:1)preprocessing(cid:1) and(cid:1)results(cid:1)in(cid:1)the(cid:1)loss(cid:1)of(cid:1)valuable(cid:1)information. 100" 90" 80" 70" 60" 50" 40" 30" 20" 10" 0" Mix,60way" Obama,"60way" Obama,"4way,"Step2" Mix,40way,"Step2" Palin,"60way" Palin,"4way,"Step2" No"Preprocessing" "Preprocessing" Figure 3. The overall accuracy in different experiments with and without preprocessing VI. CONCLUSIONS AND FUTURE WORK In this paper, we study the impact of a single-step (SRDC) 6 way classification versus a two-step classi- fication (TRDC). Our contributions in this paper are two-fold: (1) We boosted the pipeline by decoupling the rumor detection from the classification task. We proposed an automated TRDC pipeline that employs the results from the rumor detection step and performs the classification task upon data and leads to promising results in comparison to SRDC. (2) We employed a new set of meta linguistic and pragmatic features, which leads and performs the experiments with and without preprocessing on the textual content. We achieved the F-Measure of more than 0.82 and 0.85 on a mixed and the Obama rumor data sets, respectively. Our proposed features achieved better performance compared to the state of the art features proposed in [1]. Our study however suggests that our pipeline does not benefit from preprocessing which might be attributed to the weakness of the tools used for processing twitter content at this stage. We are planning to expand the proposed method- ology to streaming tweets. Having a limited amount of labeled data, we are investigating means of augmenting the training data with noisy data in a semisupervised framework. ACKNOWLEDGEMENT This paper is based upon work supported by the DARPA DEFT Program. with Hashtags Performance Prediction and Multi-Document Summarization," Initiative for the Evaluation of XML Re- trieval (INEX), July. 2013, pp. 1245-1255. [17] A. Agarwal, B. Xie, I. Vovsha, O. Rambow, and R. Passon- neau, "Sentiment analysis of Twitter data," In Proceedings of the Workshop on Languages in Social Media. Association for Computational Linguistics, June. 2011. pp. 30-38. [18] S. Richard, A. Perelygin, J. Y. Wu, J. Chuang, C. D. Manning, A. Y. Ng, and C. Potts, "Recursive deep models for semantic compositionality over a sentiment treebank," Proceedings of the conference on empirical methods in natural language processing (EMNLP). vol. 1631, 2013, pp. 1642. [19] G. A. Miller, WordNet: A Lexical Database for English, Cambridge, MA: MIT Press, Communications of the ACM Vol. 38, No. 11, pp. 39-41. [20] A. Ritter, S. C. Mausam, and O. Etzioni, Named entity recognition in tweets: an experimental study. In Proceedings of the Conference on Empirical Methods in Natural Language Processing (EMNLP 11). Association for Computational Lin- guistics, Stroudsburg, PA, USA, 2011, pp. 1524-1534. [21] T. Nasukawa and J. Yi, "Sentiment analysis: capturing fa- vorability using natural language processing," In Proceedings of the 2nd international conference on Knowledge capture, ACM. 2003, pp. 70-77. [22] C. Silverman, The Poynter Institute, "Verification Handbook," European Journalism Centre. [23] C. Castillo, M. Mendoza, and B. Poblete, "Predicting infor- mation credibility in time-sensitive social media", Internet Research. 23 (5), 2013, pp. 560-588. [24] R. S. Young and N. J. Belkin, "Understanding judgment of information quality and cognitive authority in the WWW," In Proceedings of the 61st Annual Meeting of the American Society for Information Science. ASIS, 1998, pp. 279-289. [25] H. Mark, F. Eibe, H. Geoffrey, P. Bernhard, P. Reute- mann, and I. H. Witten, The WEKA data mining software: an update. SIGKDD Explor. Newsl. 11, 1 (November 2009), 10-18. DOI=10.1145/1656274.1656278 http://doi.acm.org/10.1145/1656274.1656278. Sep. 2015. [26] Wikipedia contributors. "List of emoticons," Wikipedia, The Free Encyclopedia. Sep. 2015. [27] www.twitter.com, Sep. 2015. REFERENCES [1] V. Qazvinian, E. Rosengren, D. R. Radev, and Q. Mei, "Rumor has it: identifying misinformation in microblogs," In Proceedings of the Conference on Empirical Methods in Natural Language Processing EMNLP, Association for Computational Linguistics, Stroudsburg, PA, USA, 2011, pp. 1589-1599. J. Harsin, "The Rumour Bomb: Theorising the Convergence of New and Old Trends in Mediated US Politics," Southern Review: Communication, Politics and Culture. Issue 1, 2006, pp. 84-110. [2] [3] C. Ghaoui, "Encyclopedia of Human-Computer Interaction," Encyclopedia of human computer interaction. IGI Global, 2005. [4] C. Budak, D. Agrawal, and A. E. Abbadi, "Limiting the spread of misinformation in social networks," Proceedings of the 20th international conference on World wide web, ACM. 2011, pp. 665-674. [5] C. Budak, D. Agrawal, and A. E. Abbadi, "Detecting misin- formation in online social networks using cognitive psychol- ogy," Human-centric Computing and Information Sciences. 2014, pp. 4-14. [6] E. Seo, P. Mohapatra, and T. Abdelzaher, "Identifying rumors and their sources in social networks, SPIE Defense, Security, and Sensing," International Society for Optics and Photonics, 2012. [7] O. Owoputi, O. Connor, B. Dyer, C. Gimpel, and K. Schnei- der, "Part-of-speech tagging for Twitter: Word clusters and other advances," School of Computer Science, Carnegie Mel- lon University, Tech, 2012. [8] C. Silverman, "Verification Handbook: A Definitive Guide to Verifying Digital Content for Emergency Coverage," Euro- pean Journalism Centre, 2014. [9] C. N. Wathen and J. Burkell, "Believe it or not: Factors influencing credibility on the Web. Journal of the American Society for Information Science and Technology," 53, no 2, 2002, pp. 134-144. [10] T. Takahashi and N. Igata, "Rumor detection on Twitter," Soft Computing and Intelligent Systems (SCIS) and 13th International Symposium on Advanced Intelligent Systems (ISIS), 2012, pp. 452-457. [11] R. H. Knapp, "A Psychology Of Rumor," Public Opinion Quarterly, 1944, pp. 22-37. [12] G. Allport and J. Postman, "Psychology of Rumor," Russell and Russell. 1951, p. 750. [13] K. Starbird, J. Maddock, M. Orand, P. Achterman, and R. Mason, "Rumors, false flags, and digital vigilantes: misinfor- mation on Twitter after the 2013 Boston marathon bombing," iSchools, 2014. [14] T. Kurt, G. Chris, S. Dawn, and P. Vern, "Suspended Accounts in Retrospect: An Analysis of Twitter Spam," Proceedings of the ACM SIGCOMM Conference on Internet Measurement Conference, 2011, pp. 243-258. [15] A. Hassan, V. Qazvinian, and D. Radev, "What's with the attitude?: identifying sentences with attitude in online discus- sions," In Proceedings of the 2010 Conference on Empirical Methods in Natural Language Processing Association for Computational Linguistics, Oct. 2010. [16] R. Deveaud and F. Boudin, "Effective tweet Contextualization
1712.07708
2
1712
2018-01-24T22:34:58
Causal Feature Selection for Individual Characteristics Prediction
[ "cs.SI" ]
People can be characterized by their demographic information and personality traits. Characterizing people accurately can help predict their preferences, and aid recommendations and advertising. A growing number of studies infer people's characteristics from behavioral data. However, context factors make behavioral data noisy, making these data harder to use for predictive analytics. In this paper, we demonstrate how to employ causal identification on feature selection and how to predict individuals' characteristics based on these selected features. We use visitors' choice data from a large theme park, combined with personality measurements, to investigate the causal relationship between visitors' characteristics and their choices in the park. We demonstrate the benefit of feature selection based on causal identification in a supervised prediction task for individual characteristics. Based on our evaluation, our models that trained with features selected based on causal identification outperformed existing methods.
cs.SI
cs
Causal Feature Selection for Individual Characteristics Prediction Tao Ding∗, Cheng Zhang†, and Maarten Bos† ∗ Department of Information Systems University of Maryland, Baltimore County [email protected] ∗ †Disney Research, Pittsburgh, USA {cheng.zhang,mbos}@disneyresearch.com 8 1 0 2 n a J 4 2 ] I S . s c [ 2 v 8 0 7 7 0 . 2 1 7 1 : v i X r a Abstract People can be characterized by their demographic in- formation and personality traits. Characterizing people accurately can help predict their preferences, and aid recommendations and advertising. A growing number of studies infer peoples characteristics from behavioral data. However, context factors make behavioral data noisy, making these data harder to use for predictive analytics. In this paper, we demonstrate how to em- ploy causal identification on feature selection and how to predict individuals' characteristics based on these se- lected features. We use visitors' choice data from a large theme park, combined with personality measurements, to investigate the causal relationship between visitors characteristics and their choices in the park. We demon- strate the benefit of feature selection based on causal identification in a supervised prediction task for individ- ual characteristics. Based on our evaluation, our models that trained with features selected based on causal iden- tification outperformed existing methods. Introduction Understanding an individual's characteristics is useful for many real life applications. The term individual characteris- tics refers to individual differences in characteristic patterns of thinking (Widiger 2011), and includes both demograph- ics and personality. Knowing someone's individual charac- teristics can help to understand that person's preferences, which has important applications ranging from health care (Smith and Spiro III 2002; Giota and Kleftaras 2013) to marketing (Spence et al. 1997; Odekerken-Schroder et al. 2003; Jamal and Goode 2001; Lin 2002; Wang et al. 2013; Yang et al. 2015; Ding and Pan 2016), health (Booth- Kewley and Vickers 1994; Smith and Spiro III 2002; Giota and Kleftaras 2013) and public politics (Greenstein 1992; Caprara et al. 2006; Chirumbolo and Leone 2010). Individ- ual characteristics – such as gender and personality - are rel- atively stable over time. E.g. the people who display higher score of a particular personality trait continue to display higher score of this personality trait over time, when com- pared to other individuals (Caspi et al. 2005). This means that it is practical, and relatively stable over time, to predict ∗This work was accomplished during the period of the first au- thor working as research intern in Disney Research. Figure 1: An exemple of individual characteristics predic- tion using theme park activities. The activities are caused by both the target individual's preferences and the contextual situation, which in this case is the accompanying child. To separate the signal from noise for the individual characteris- tics prediction task, we propose to use a causal identification method to determine the informative activity for this task. a person's behavior and preferences from individual charac- teristics. Personality information can be arduous to obtain. A tra- ditional approach to measuring personality requires partici- pants to take a psychological test (e.g. filling out question- naires), which is time-consuming and difficult to scale up. It is therefore desirable to circumvent this testing process and instead directly predict individual characteristics based on readily available observational data. A growing proportion of human activities, such as con- suming entertainment, shopping, and social interactions, are now mediated by digital services and devices. These digital footprints of consumer behaviors can be recorded and ana- lyzed. Understandably, there is an interest in automatically predicting individual characteristics including age, gender, income and personality traits from these digital footprints. In this work, we focus on predicting individual characteris- tics from real-life experiences in theme parks. This task is challenging because behavioral data are noisy. Noisiness can be caused by different factors, such as that while people move in groups, we are trying to pre- dict personality at an individual level (Elliot et al. 2012; Zhang et al. 2015). In our study we use behavioral data, such as which facilities a person visited during their stay in the theme park, to predict traits such as openness or agreeable- ness. Imagine a person is visiting a theme park with his/her child, as shown in Figure 1, and our goal is to predict the parent's traits. The activities of the parent are influenced by the fact that the child is with them. For example, a visit to a toy shop may not be the result of the parent's traits, but of the context factor (the child). The signal of the parent's personality is partially drowned out by the noise of the con- text. This makes it challenging to distinguish individual dif- ferences from group behaviors. Identifying which behaviors are directly caused by a person's characteristics is essential. In the paper, we propose a new machine learning pipeline to predict individual characteristics. We present a study on 3294 visitor profiles of a large theme park. We first employ causal identification to identify individual behavioral fea- tures. Second, we use these features to build predictive mod- els to predict specific personality traits. Our contribution is threefold: 1. This is the first study that investigates the relationship be- tween someone's location history (defined as visits of fa- cilities in a theme park) and their personality. 2. We take advantage of causal identification methods for feature selection and build a prediction model to pre- dict individual characteristics. Our results demonstrate improvement over baseline models, such as models that use all features or models that use traditional feature se- lection methods. 3. Compared to other machine learning methods, causal identification is able to obtain interpretable results in a principled way and provide more insights in behavior. Background and Related Works We aim to predict individual characteristics from real-life theme park visits data with causal identification for feature selection. Therefore we first explain why individual charac- teristics are interesting and important. Then we summarize related work on individual characteristics prediction using various type of data. Finally we discuss research on causal identification and causal inference. Individual characteristics We define individual charac- teristics as both demographic information and personality traits. In the context of our application, demographic infor- mation includes age, income, and the number of kids in- cluded in a theme park visit; personality traits are described using the well established Big5 personality model (Goldberg 1993). The Big5 personality model (Goldberg 1993) repre- sents personality with scores on five personality traits. These traits are openness, conscientiousness, extraversion, agree- ableness and neuroticism. Table 1 shows a description of the traits. The Big5 model is widely used to represent a person's personality. There is a rich body of work in behavioral science on the relationship between humans' individual characteristics and their real-world behaviors. Table 1: Big Five personality model (Ding and Pan 2016) Personality Openness Conscientiousness Extraversion Agreeableness Neuroticism Description A person's level of intellectual cu- riosity, creativity and preference for novelty and variety. A person's tendency to be orga- nized and dependable, show self- discipline, act dutifully, and prefer planned rather than spontaneous be- havior. A person's energy, positivity, as- sertiveness, sociability, talkative- ness, and tendency to seek stimula- tion from the company of others. A person's tendency to be com- passionate and cooperative. Also a measure of one's trustingness, help- fulness, and well-tempered nature. A person's tendency to experi- ence unpleasant emotions easily, and have low emotional stability and impulse control. One example study showed that age, level of educa- tion, and income among 250 hotel restaurant customers was correlated with complaint behavior (Sujithamrak and Lam 2005). Another study revealed a relationship between smok- ing behavior and demographic variables (Moody 1980). Be- sides demographics, personality traits also predict behav- ior. One study found that smokers score higher on openness to experience and lower on conscientiousness, a personal- ity trait related to a tendency to show self-discipline, act dutifully, and aim for achievement (Campbell et al. 2014). A second study examined the link between personality and alcohol consumption and found that alcohol use is corre- lated positively with sociability and extraversion (Cook et al. 1998). Another study showed a link between personal envi- ronments and personality (Gosling et al. 2002). Yet another study (Fennis and Pruyn 2007) found that a brand's person- ality profile may carry over and affect perceptions of the per- sonality of the brand's owner. These studies are often car- ried out using questionnaires, surveys, or interviews. These methods are time-consuming, and a more efficient way to predict traits would be useful. Machine Learning for Individual Characteristics Predic- tion Using machine learning methods to predict individual characteristics from behaviors has increasingly gained atten- tion. Ideally, various types of real-life behavior data would be used to predict individual characteristics. However, exist- ing research is mainly limited to the use of social network data to predict individual characteristics. There have been several studies to show that users' dig- ital footprints on social networks can be used to infer their demographics and personalities (Farnadi et al. 2013; Figure 2: The Distribution of Big 5 Personality traits. (a) Agreeableness (b) Conscientiousness (c) Extraversion (d) Neuroticism (e) Openness Mislove et al. 2011; Golbeck et al. 2011; Kosinski et al. 2013). When there is a large volume of data available especially for high dimensional data feature learning is needed to reduce data dimensionality (Kosinski et al. 2015; Pennebaker et al. 2007; Kosinski et al. 2013; Schwartz et al. 2013). An alternative to this approach is supervised learning. Studies often focus on recognizing individual characteristics from a limited amount of noisy annotated data, using uni- variate and multivariate regression formulations. Supervised learning can be used either on the raw data or on extracted features. These features can be extracted using representa- tion learning methods. In supervised learning, feature se- lection can improve the accuracy of the learning algorithm. There are existing methods to identify relevant features and remove irrelevant and redundant features before training a model. In a regression model, the common method is to ap- wi to the loss function (L1-norm), which forces weak features to have zeros as coefficients. This is also called LASSO regression (Tibshirani 1996). This inherently creates feature selection. Another method is correlation based feature selection (CFS) which filters the features by performing feature selection based on correlation analysis (Yu and Liu 2003). However, both these methods do not provide interpretable results and lack principled justification. ply L1 regularization that adds a penalty α(cid:80)i=1 n Causal Identification A fundamental assumption for re- search on individual characteristics prediction is the causal relationship between the individual characteristics and be- haviors. Additionally, prediction is only possible if the target is the cause of the data (effect) (Scholkopf et al. 2012). Most feature selection methods do not attempt to un- cover cause-effect relationships between feature and target (Guyon et al. 2007). A correlated feature may be predic- tive of an outcome without intervention. Causal identifica- tion (Spirtes et al. 2000) can identify features with direct ef- fects caused by target variables which contain predictive in- formation of the target. Additionally, the result from causal identification - a graph indicating causal relationships - is highly interpretable. In individual characteristics identifica- tion, causal identification is able to determine which behav- iors are caused by individual characteristics and which be- haviors are caused by the context. In this paper, we apply Table 2: The Meta-data of User's Profile Item Gender Age Total visits Vacation days Income Trip cost # of children Hotel choice How the trip was booked Dining plan First park vis- ited Data Type Categorical Categorical Numerical Numerical Numerical Numerical Numerical Categorical Categorical Categorical Categorical Representation 0: male 1: fe- male 17-78 0-99 0-99 1-14 0-9999 0-9 0: No 1: Yes 13 categories 0: No 1: Yes 4 theme parks different different causal identification methods to identify direct ef- fects caused by personal traits. Using causal identification methods for feature selection leads to better predictive per- formance in our application. Dataset The data for our study were collected from visitors of a large theme park resort. The resort has over 30 hotels, more than 100 restaurants and hundreds of attractions. We assume in- dividual characteristics affect the choices visitors make. We asked visitors' permission to use their choice and location history. From visitors who agreed to this we retrieved the lo- cations they visited, including restaurants, stands and kiosks, attractions&rides, stores and other entertainment. Participat- ing visitors also allowed us access to data such as their park entry time, hotel check-in time, purchases, and other meta- data such as length of stay, trip cost, and which of the parks they visited first (see Table 2). Visitors who participated in our study were asked to fill out a questionnaire, in which they were asked about the pre- viously mentioned experiences at the resort, as well as de- mographical questions and the Ten-Item Personlity Inven- tory (TIPI). The TIPI was developed as a shortened version of a 50-item personality scale and is often used to mea- sure Big5 personality traits. The TIPI has 10 items, with Figure 3: The Distribution of Demographics (a) Gender (b) Age (c) # of children two items measuring each of the personality traits. The TIPI uses a 7-point Likert scale from 1 ("Strongly Agree") to 7 ("Strongly Disagree"). For every participant, we average the scores of the items associated with the personality to achieve five personality scores. A total of 3997 visitors participated. After filtering out the responses with missing values, we collected the individual characteristics of 3293 participants. Figure 3 show the dis- tribution of demographics. In the remaining data 31% of are males and 69% are females. The average age is 44 years old. The average number of children in the group is 1.2. Figure 2 show the distribution of big5 personalities. The range of the scores are between [1,7]. Our participants experienced a total of 505 different things in the park. The objective of the study is to measure individual dif- ferences based on visitors' experiences and choices at the theme park resort. As mentioned, studies that analyze peo- ple's digital footprints generally have an advantage in that they are more likely to reflect the choices of the individual filling out the personality survey (such as Facebook likes, publishing/commenting etc.). Most people do not visit the theme parks alone (the average group size is larger than 3 in our dataset). We have to assume that in many cases par- ents make decisions based on their children's preferences. That makes it difficult to link individual characteristics to the choices made by the parents. In the following section, we employ causal inference to capture effects caused by in- dividual characteristics in order to reduce others' impacts in decision making. Causal Identification Causal identification aims at inferring causal relationships from observational data (Pearl 2009; Imbens and Rubin 2015). Many observed correlations in observational data are mediated through unobserved confounding variables. The goal of causal identification is to distinguish between such mediated correlations and truly causal relationships. The basis of our causal identification analysis is a Bayesian network. This is a directed acyclic graph (DAG) in which nodes represent variables and arrows between the nodes represent the direction of causation between the nodes. The problem is that we only observe the nodes; these are our observations (location data, metadata, and the Big5 scores). We want to infer arrows that best explain the ob- served correlations. This is done in such a way that the num- ber of causal arrows between the nodes is, in some sense, minimal to be consistent with the observed correlations. Having identified the causal structure, we exclude all pre- dictor variables which are not causally associated with the target variables of interest. This is the central idea of how we propose to select features. There are two main classes of algorithms to learn causal DAGs from observational data: constraint-based and score- based ones. Constraint-based methods use independence and dependence constraints obtained from statistical tests to narrow down the candidate graphs that explain the data. Our first proposed method relies on using the PC algorithm (Spirtes and Meek 1995) for feature selection; it belongs to the first class. The algorithm begins by learning an undi- rected Bayesian network that explains the variations by run- ning conditional independence tests. The second phase con- sists of orienting the Bayesian network, thereby avoiding cy- cles and v-structures. We use a significant level of 0.05 in the independent test. Score-based methods, on the other hand, provide a metric of confidence in the entire output model. The algorithm we use in this paper is Fast Greedy Equivalence Search (FGES), which greedily searches over Bayesian network structures (Ramsey 2015), and outputs the highest scoring model it finds. The score which the algorithm uses is the Bayesian Information Criterion (BIC) (Raftery 1995): BIC = 2 · ln P (dataθ, M ) − c · k · ln(n). Above, M denotes the Bayesian network, θ denotes its pa- rameters, k is the total number of parameters, and n the num- ber of data points. The constant c is a free parameter that we can tune. This constant penalizes large numbers of parame- ters and thus determines the complexity of the network; we chose c = 0.1 to obtain a comparable number of features between PC and FGES. The FGES performs a forward step- ping search in which edges are added between nodes in order to increase the BIC until no single edge addition increases the score. Then, it performs a backward stepping search in which unnecessary edges are removed. Both the PC and FGES algorithms are used in this paper for feature selection and compared against the LASSO ap- proach in our experimental section. The L1 term 1 is set as 0.01 to obtain a comparable number of features. Predictive Evaluation We implemented different prediction models to infer indi- vidual characteristics from location history and metadata. The experiments are designed to answer the following ques- tions: a) Can the visitors' choices infer individual character- istics? b) Is there any benefit of performing feature selection according to causal identification? c) Is metadata informa- tive to predict individual characteristics? To answer (a), we denote the visitors' choice history as a binary representation of a fixed size vector, 1 represents that the visitor visited a place. We use LASSO (Least Absolute Shrinkage and Selec- tion Operator)(Tibshirani 1996) linear regression to perform predictive tasks for continuous outcomes like age, income, 1We tried different values of c = 1, 0.1, 0.01, without noticing a significant change in predictive performance. Figure 4: Stability of Feature Selection for Big5 Personality. (a) Agreeableness (b) Conscientiousness (c) Extraversion (d) Neuroticism (e) Openness Table 3: Root mean square error (RMSE) and coefficient of determination (R2) results for the personality prediction using visitors' choices and metadata ApproachAgr R2 RMSE Cons R2 Extr RMSE R2 Neu RMSE R2 Open RMSE R2 RMSE -0.085 1.802 1.502 Visitors' choices LASSO -0.090 1.143 PC 1.770 FGES Visitors' choices+Metadata LASSO 5.942 0.170 0.169 6.208 PC 6.951 0.169 FGES The five personality are Extraversion(Extr), Agreeableness(Agr), Conscientiousness(Cons),Neuroticism(Neu), and Openness(Open). LASSO: α = 0.01. PC: p = 0.05. FGES: c = 0.1. -0.065 1.954 1.646 -0.121 1.090 1.088 -0.338 2.248 2.482 0.192 0.190 0.190 0.189 0.189 0.189 0.171 0.170 0.170 0.166 0.166 0.165 0.175 0.174 0.174 0.174 0.172 0.172 0.242 0.240 0.239 0.242 0.239 0.239 -0.087 1.975 2.368 2.109 2.959 2.995 1.047 2.388 2.251 0.171 0.169 0.169 1.152 3.625 3.525 the number of children and personality. LASSO is a regres- sion method that automatically performs both feature selec- tion and regression. All results are based on 10-fold cross validation to avoid overfitting. To answer (b), we run PC and FGES to search for causal explanations on training data for each fold. We train predictive models by using effects of features caused by specific characteristics and predict indi- vidual characteristics on the test set. To answer (c), we add metadata in models trained in (a) and (b) to see whether the performance improves. To identify causal relationships, we employ a Tetrad (Spirtes et al. 2000)2 analysis to manipulate and individu- ally study the different individual characteristics. Tetrad pro- vides different causal search algorithms to search when there may be unobserved cofounders of measured variables and output graphical representations (Scheines et al. 1998). In our experiment, we run PC and FGES search algorithms. In PC search, we choose a Fisher-z transformation to do in- dependent tests which converts correlations into an almost normally distributed measure. The p-value is set at 0.05. In FGES setting, the penalty discount, which is c in the BIC formula, is set to 0.1 in order to get a similar number of fea- tures as the PC algorithm can get from training data. Stability Test To compare the stability of feature selection methods, we calculated the selection probability for each 2http://www.phil.cmu.edu/tetrad/ feature in the Big5 personality prediction task under boot- strapping, following (Mandt et al. 2017). We thereby ran- domly removed 10 percent of the data and applied our fea- ture selection algorithms on the remaining data. We repeated this procedure 10 times and computed the empirical feature selection probabilities. Figure 4 shows the results, where the features have been ranked according to their selection prob- ability. We see that the top 5-10 features are mostly sta- ble across all methods, with a slightly better performance of the LASSO method on extraversion, conscientiousness and agreeableness, and with a slightly better performance of our proposed causal identification methods on openness and neuroticism.Note that the features selected by the different methods are different. Next, we compare how well the se- lected features serve in our personality prediction task. Predictive Performance To evaluate performance, for continuous outcomes, we evaluate the results based on root mean squared error (RMSE) and Co-efficient of Determina- tion(R2). RM SE measures the difference between values the model predicted and the observed values. RM SE can be described by the following formula: (cid:115)(cid:80)n RM SE = t=1(yt pred)2 obs − yt n obs and yt pred are the observed and predicted scores where yt for instance t, and n is the sample size. R2 is the ratio of Table 4: Root mean square error (RMSE) and coefficient of determination (R2) results for the demographics using visitors' choices and metadata Approach Age R2 Visitors' choices LASSO 2.294 13.675 PC 13.843 FGES RMSE 0.146 0.137 0.137 Visitors' choices+Metadata LASSO 8.432 21.684 PC 21.975 FGES 0.141 0.131 0.131 # of Children R2 RMSE Income R2 RMSE -16.53 0.097 0.815 -2.386 8.618 9.539 0.153 0.142 0.141 0.143 0.135 0.135 -0.352 8.160 8.107 1.160 10.936 10.606 0.256 0.245 0.245 0.255 0.242 0.242 LASSO: α = 0.01. PC: p = 0.05. FGES: c = 0.1. the model's absolute error and the baseline mean predicted scores. It is expressed as: 1 − R2 = 100 × (cid:80)n (cid:80)n obs − yt pred)2 obs − ¯yobs)2 (cid:33) (cid:32) (cid:80)n t=1(yt t=1(yt t=1 yt obs is the mean of the observed Above, ¯yobs = 1 n scores. R2 contains the ratio of the variance of the predic- tion over the empirical variance of the scores. If this ratio is small, the prediction is accurate and R2 is large. If the ratio approaches 1, then R2 approaches 0. Negative values indicate that the prediction is not reliable. Usually, the metadata are informative for individual char- acteristics, e.g. the trip cost is correlated with income and the number of children; gender is correlated with person- ality. To examine the effectiveness of metadata in predic- tion performance, we have two datasets in the experiments: one includes only the visitors' choices, while the other one includes both the visitors' choices and metadata. Table 3 shows the prediction performance of the Big5. The LASSO model without metadata shows visitors' choices did not cap- ture enough predictive information, because all R2 score are lower than 0. Besides, We also compare prediction perfor- mance of three feature selection methods. After employing causal identification in feature selection, the performance is higher than using LASSO. The highest R2 score is ob- tained from FGES in predicting extraversion (R2 = 2.368). The lowest RMSE is obtained from PC and FGES model in openness prediction. When the metadata are added in the models, the overall performance of all models improves, e.g. the performance of predicting agreeableness increased from R2 = 1.77 to R2 = 6.951 which is the best performance for the Big5. Table 4 shows the prediction performance of demographic information. Among the results of three outcomes (age, the number of children and income), visitors' choices are more helpful to predict age (R2 = 2.294) than to predict the number of children(R2 = −16.53) and income(R2 = −0.352) in Lasso models. This means the visitors' choices are more informative to infer age. Meanwhile, after meta- data are included in the model, the overall performance im- proves. In general, the R2 results of causal identification show the models outperform the constant average baseline. The FGES model for predicting age and the number of chil- dren achieved best performance with R2 = 13.843 and R2 = 0.815. The PC model for predicting income achieved best performance with R2 = 8.160. In summary, there are two findings from predictive evalu- ation: 1) we prove the effectiveness of the metadata in pre- dicting individual characteristics; 2) the features selected based on causal identification can improve the prediction performance of individual characteristics. Causal Relationship Analysis In addition to building models that predict individual char- acteristics, we are also interested in understanding the causal relationship between a visitor's characteristics and their choices. The Tetrad method specifies causal relations among the variables via a representation of a directed graph. The edge X → Y can be interpreted as X has a direct causal effect on B. We extract causal relationships between person- ality traits and visitors' choices with metadata from CBN, which are showed in table 5. Within the 505 locations, agree- ableness and neuroticism have direct causal effects only on 5 of the guests' choices. Agreeableness links to some spe- cific quick food restaurants and some gift shops (we omit actual names of these locations). People who score higher agreeableness tend to visit popular parks (Park A and Park b) which are visited by most people. People who score higher on neuroticism link to some family style restaurants and dining events, which mean they tend to enjoy the com- fort associated with environment. Conscientiousness has di- rect causal effects on 10 locations, most are facilities lo- cated in a specific hotel area of the theme park resort area, which means that conscientious people may be more likely to spend time near their hotel. Openness has direct causal effects on 10 location visits including thrill rides, quick food restaurants, and indoor theatres. Comparing with other per- sonality traits, people who score higher openness link to most thrill rides with big drop, which mean they enjoy new experiences and seek out adventure. Extraversion has direct effects on visits of many different places (13 places, located in 6 different parks). Table 5: Identified items that are caused by personality found by PC algorithm. Each [.] present a facility or a meta feature which are used as features. Apart from the personal meta data, only the facility ids are used in our method. Due to confidentiality, we do not list the names of the facilities; we only show the metadata of the facilities to interpret the results. The metadata of the facilities themselves are not used in the analysis. The blue colored features indicate that the causal relationships are mutual. Trait Agr Cons Neu Extr Open [Park A: Housewares, [Park B: Toys, Apparel, Accessories], Services/Metadata [Park A: Restaurants, Quick Service], Food], [Park A: Gift shop], [Park B: Housewares, Apparel, Accessories], [age], [gender] [Park A: Camera, Media, Apparel, Accessories], [Resort A], [Resort B: Spa, Pool Bars], [Resort B: Restau- rants, Quick Service], [Resort B: Restaurants, Table Service], [Park: Restaurants, Quick Service], [Resort C: Apparel, Accessories], [Park F: Camera, Media, Apparel, Accessories], [Park C: Gift shop], [Park D: Apparel, Accessories], [income] [Park A: Restaurants, Character dining], Buffet/Family Style], [Park A: Restaurants, Table service], [Park A: Gift shop], [age], [income] [Park C: Restaurant, Quick Service ], [Park A: Character showcase, Preschool, Kids], [Park C: Gift shop, Apparel, Accessories], [Park C: Indoor theater], [Park D: Gift shop, Camera, Media], [Resort A], [Resort D: Lounges], [Park A: Apparel, Accessories], [Park D: Restaurant, Character Dining, Family Style], [Park E: Gift shop], [Park A: Art Collection, Gift shop], [Resort E: Health beauty], [Park F: Gift shop, Apparel, Accessories], [gender], [# of children] [Park A: Thrill ride], [Park G: Thrill ride] , [Park A: Thrill ride], [Park D: Indoor theatre], [Park D: Restau- rants, Quick Service], [Park A: Restaurants, Quick Service], [Park A: Restaurants, Quick Service], [Park A: Gift shop, Apparel, Accessories], [Park A: Slow ride], [Park D: Gift shop, Apparel, Accessories], [age] [Park A: Restaurants, Table service], [Resort D: Restaurants, Discussion We demonstrated predictive improvements by using causal identification. Personality inference is complex and can be influenced by factors such as age (Caspi and Silva 1995), income (Raadal et al. 1995), family environment (Hoffman 1991) and cultural differences (Hofstede and McCrae 2004). We did not try to capture all the relevant factors in our model, instead we only used the metadata of a visitors' pro- file that they shared with us. However, if one were to analyze a fuller picture of visitors' choices - such as when they were where - this might show to be a more interpretable causal relationship. Meanwhile, in our model, we only use the item ids of facilities in park without exploring causal relation- ships between individual characteristics and the facilities' metadata. Basically any data that are a direct result of the target person's decision-making could be helpful to predict that person's characteristics. Conclusion In our study, we focused on three main tasks. (1) We em- ployed causal identification to select features which are most informative of individual characteristics (2) we built per- sonal traits prediction models based on guests' choices and metadata (3) we employed causal relationship analysis to obtain human interpretable results. Our investigation has shown that models using causal identification significantly outperform the baseline models in all individual characteris- tics' prediction, as well as demonstrated the causal relation- ships between guests' choices and their personality traits. Acknowledgement We appreciate Michelle Ma for providing the illustration of an example in our paper. We are also grateful to Kun Zhang for his valuable advice and guidance about identify- ing causal relationship using Tetrad. References Stephanie Booth-Kewley and Ross R Vickers. Associations be- tween major domains of personality and health behavior. Journal of personality, 62(3):281–298, 1994. Stephen Campbell, Lyndsay Henry, Jackie Hammelman, and Maya Pignatore. Personality and smoking behaviour of non-smokers, J Addict Research & previous smokers, and habitual smokers. Therapy, 5:191, 2014. Gian Vittorio Caprara, Shalom Schwartz, Cristina Capanna, Michele Vecchione, and Claudio Barbaranelli. Personality and politics: Values, traits, and political choice. Political psychology, 27(1):1–28, 2006. Avshalom Caspi and Phil A Silva. Temperamental qualities at age three predict personality traits in young adulthood: Longitudinal evidence from a birth cohort. Child development, 66(2):486–498, 1995. Avshalom Caspi, Brent W Roberts, and Rebecca L Shiner. Per- sonality development: Stability and change. Annu. Rev. Psychol., 56:453–484, 2005. Antonio Chirumbolo and Luigi Leone. Personality and politics: The role of the hexaco model of personality in predicting ideology and voting. Personality and Individual Differences, 49(1):43–48, 2010. Mark Cook, Alison Young, Dean Taylor, and Anthony P Bedford. Personality correlates of alcohol consumption. Personality and In- dividual Differences, 24(5):641–647, 1998. Tao Ding and Shimei Pan. Personalized emphasis framing for persuasive message generation. arXiv preprint arXiv:1607.08898, 2016. Aronson Elliot, Wilson Timothy D., and Robin M. Akert. Social psychology. Pearson Education Canada, 2012. Golnoosh Farnadi, Susana Zoghbi, Marie-Francine Moens, and Martine De Cock. Recognising personality traits using facebook status updates. In ICWSM13. AAAI, 2013. Bob M Fennis and Ad Th H Pruyn. You are what you wear: Brand personality influences on consumer impression formation. Journal of Business Research, 60(6):634–639, 2007. Kyriaki G Giota and George Kleftaras. The role of personality and depression in problematic use of social networking sites in greece. Cyberpsychology: Journal of Psychosocial Research on Cyberspace, 7(3), 2013. Jennifer Golbeck, Cristina Robles, and Karen Turner. Predicting In CHI'11 extended abstracts on personality with social media. human factors in computing systems, pages 253–262. ACM, 2011. Lewis R Goldberg. The structure of phenotypic personality traits. American psychologist, 48(1):26, 1993. Samuel D Gosling, Sei Jin Ko, Thomas Mannarelli, and Margaret E Morris. A room with a cue: personality judgments based on of- fices and bedrooms. Journal of personality and social psychology, 82(3):379, 2002. Fred I Greenstein. Can personality and politics be studied system- atically? Political Psychology, pages 105–128, 1992. Isabelle Guyon, Constantin Aliferis, and Andr´e Elisseeff. Causal feature selection. Computational methods of feature selection, pages 63–82, 2007. Lois W Hoffman. The influence of the family environment on per- sonality: Accounting for sibling differences. Psychological Bul- letin, 110(2):187, 1991. Geert Hofstede and Robert R McCrae. Personality and culture re- visited: Linking traits and dimensions of culture. Cross-cultural research, 38(1):52–88, 2004. Guido W Imbens and Donald B Rubin. Causal inference in statis- tics, social, and biomedical sciences. Cambridge University Press, 2015. Ahmad Jamal and Mark MH Goode. Consumers and brands: a study of the impact of self-image congruence on brand preference and satisfaction. Marketing Intelligence & Planning, 19(7):482– 492, 2001. Michal Kosinski, David Stillwell, and Thore Graepel. Private traits and attributes are predictable from digital records of hu- man behavior. Proceedings of the National Academy of Sciences, 110(15):5802–5805, 2013. Michal Kosinski, Sandra C Matz, Samuel D Gosling, Vesselin Popov, and David Stillwell. Facebook as a research tool for the social sciences: Opportunities, challenges, ethical considerations, and practical guidelines. American Psychologist, 70(6):543, 2015. Chin-Feng Lin. Segmenting customer brand preference: demo- graphic or psychographic. Journal of Product & Brand Manage- ment, 11(4):249–268, 2002. Stephan Mandt, Florian Wenzel, Shinichi Nakajima, John Cun- ningham, Christoph Lippert, and Marius Kloft. Sparse probit linear mixed model. Machine Learning, pages 1–22, 2017. Alan Mislove, Sune Lehmann, Yong-Yeol Ahn, Jukka-Pekka On- nela, and J Niels Rosenquist. Understanding the demographics of twitter users. ICWSM, 11:5th, 2011. Philip Moody. The relationships of quantified human smoking be- havior and demographic variables. Social Science & Medicine. Part A: Medical Psychology & Medical Sociology, 14(1):49–54, 1980. Gaby Odekerken-Schroder, Kristof De Wulf, and Patrick Schu- macher. Strengthening outcomes of retailer–consumer relation- ships: The dual impact of relationship marketing tactics and con- sumer personality. Journal of business research, 56(3):177–190, 2003. Judea Pearl. Causality. Cambridge university press, 2009. James W Pennebaker, Roger J Booth, and Martha E Francis. Lin- guistic inquiry and word count: Liwc [computer software]. Austin, TX: liwc. net, 2007. M Raadal, P Milgrom, P Weinstein, L Mancl, and AM Cauce. The prevalence of dental anxiety in children from low-income families and its relationship to personality traits. Journal of dental research, 74(8):1439–1443, 1995. Adrian E Raftery. Bayesian model selection in social research. Sociological methodology, pages 111–163, 1995. Joseph D Ramsey. Scaling up greedy equivalence search for con- tinuous variables. CoRR, abs/1507.07749, 2015. Richard Scheines, Peter Spirtes, Clark Glymour, Christopher Meek, and Thomas Richardson. The tetrad project: Constraint based aids to causal model specification. Multivariate Behavioral Research, 33(1):65–117, 1998. Bernhard Scholkopf, Dominik Janzing, Jonas Peters, Eleni Sgouritsa, Kun Zhang, and Joris Mooij. On causal and anticausal learning. arXiv preprint arXiv:1206.6471, 2012. H Andrew Schwartz, Johannes C Eichstaedt, Margaret L Kern, Lukasz Dziurzynski, Stephanie M Ramones, Megha Agrawal, Achal Shah, Michal Kosinski, David Stillwell, Martin EP Selig- man, et al. Personality, gender, and age in the language of so- cial media: The open-vocabulary approach. PloS one, 8(9):e73791, 2013. Timothy W Smith and Avron Spiro III. Personality, health, and aging: Prolegomenon for the next generation. Journal of Research in Personality, 36(4):363–394, 2002. Jacqui Spence, Russell Abratt, and Bobby Amos Malabie. Use of psychographics in consumer market segmentation: the south african experience. South African Journal of Business Manage- ment, 28(2):33–41, 1997. Peter Spirtes and Christopher Meek. Learning bayesian networks with discrete variables from data. In KDD, volume 1, pages 294– 299, 1995. Peter Spirtes, Clark N Glymour, and Richard Scheines. Causation, prediction, and search. MIT press, 2000. Siriporn Sujithamrak and Terry Lam. Relationship between cus- tomer complaint behavior and demographic characteristics: A study of hotel restaurants' patrons. Asia Pacific Journal of Tourism Research, 10(3):289–307, 2005. Robert Tibshirani. Regression shrinkage and selection via the lasso. Journal of the Royal Statistical Society. Series B (Method- ological), pages 267–288, 1996. William Yang Wang, Edward Lin, and John Kominek. This text has the scent of starbucks: A laplacian structured sparsity model for computational branding analytics. In EMNLP, Seattle, WA, USA, 2013. Thomas A Widiger. Personality and psychopathology. World Psy- chiatry, 10(2):103–106, 2011. Chao Yang, Shimei Pan, Jalal Mahmud, Huahai Yang, and Padmini Srinivasan. Using personal traits for brand preference prediction. In EMNLP, pages 86–96, 2015. Lei Yu and Huan Liu. Feature selection for high-dimensional data: A fast correlation-based filter solution. In ICML, pages 856–863, 2003. Cheng Zhang, John Guiver, Tom Minka, and Yordan Zaykov. Groupbox: A generative model for group recommendation, 2015.
1707.03186
3
1707
2019-09-03T12:42:25
Community Discovery in Dynamic Networks: a Survey
[ "cs.SI", "physics.soc-ph" ]
Networks built to model real world phenomena are characeterised by some properties that have attracted the attention of the scientific community: (i) they are organised according to community structure and (ii) their structure evolves with time. Many researchers have worked on methods that can efficiently unveil substructures in complex networks, giving birth to the field of community discovery. A novel and challenging problem started capturing researcher interest recently: the identification of evolving communities. To model the evolution of a system, dynamic networks can be used: nodes and edges are mutable and their presence, or absence, deeply impacts the community structure that composes them. The aim of this survey is to present the distinctive features and challenges of dynamic community discovery, and propose a classification of published approaches. As a "user manual", this work organizes state of art methodologies into a taxonomy, based on their rationale, and their specific instanciation. Given a desired definition of network dynamics, community characteristics and analytical needs, this survey will support researchers to identify the set of approaches that best fit their needs. The proposed classification could also help researchers to choose in which direction should future research be oriented.
cs.SI
cs
Community Discovery in Dynamic Networks: a Survey Giulio Rossetti∗ Knowledge Discovery and Data Mining Lab, ISTI-CNR, Pisa, Italy Remy Cazabet† Sorbonne Universites, UPMC Univ Paris 06, CNRS, LIP6 UMR 7606 and Univ Lyon, UCBL, CNRS, LIRIS UMR 5205, F-69621, Lyon, France Several research studies have shown that Complex Networks modeling real-world phenomena are characterized by striking properties: (i) they are organized according to community structure and (ii) their structure evolves with time. Many researchers have worked on methods that can effi- ciently unveil substructures in complex networks, giving birth to the field of community discovery. A novel and fascinating problem started capturing researcher interest recently: the identification of evolving communities. Dynamic networks can be used to model the evolution of a system: nodes and edges are mutable and their presence, or absence, deeply impacts the community structure that composes them. This survey aims to present the distinctive features and challenges of dynamic community discov- ery and propose a classification of published approaches. As a "user manual", this work organizes state of the art methodologies into a taxonomy, based on their rationale, and their specific instan- tiation. Given a definition of network dynamics, desired community characteristics and analytical needs, this survey will support researchers to identify the set of approaches that best fit their needs. The proposed classification could also help researchers to choose in which direction to orient their future research. Contents I. Introduction II. Dynamic Networks A. Network Models 1. Temporal Networks 2. Network Snapshots 3. Discussion: Temporal Networks vs. Snapshots B. Network Memory III. Dynamic Community Discovery A. Problem Definition 1. Community Life-Cycle B. Community Instability & Temporal Smoothing IV. Classification A. Instant-optimal Communities Discovery 1. Iterative similarity-based approaches 2. Iterative Core-nodes based approaches 3. Multi-step matching B. Temporal Trade-off Communities Discovery 1. Update by Global Optimization 2. Update by Set of Rules 3. Informed CD by Multi-objective optimization 4. Informed CD by network smoothing C. Cross-Time Communities Discovery 1. Fixed Memberships, fixed properties 2. Fixed memberships, evolving properties 3. Evolving memberships, fixed properties 4. Evolving memberships, evolving properties D. Discussion V. Evaluation A. Synthetic Network Generators B. Methodologies 1 2 3 3 4 4 5 5 5 6 8 9 11 11 11 12 12 13 13 13 14 14 14 14 15 15 15 15 16 17 ∗Electronic address: [email protected] †Electronic address: [email protected] VI. Applications A. Real World Dynamic Networks B. Visualization 1. Dynamic Visualization 2. Static Visualization C. DCD as a tool VII. Outlook Acknowledgement References VIII. Instant-optimal Community Discovery A. Iterative similarity-based approaches B. Iterative core-nodes based approaches C. Multi-step matching IX. Temporal Trade-off Communities Discovery A. Partition update by Global optimization B. Informed CD by Multi-objective optimization C. Partition update by set of rules D. Informed CD by network smoothing X. Cross-Time Communities Discovery A. Fixed Memberships, fixed properties B. Fixed memberships, evolving properties C. Evolving memberships, fixed properties D. Evolving memberships, evolving properties 19 19 20 20 20 21 22 23 23 28 28 29 30 30 30 31 32 33 34 34 35 35 35 I. INTRODUCTION Complex Networks (Newman, 2003) are popular tools -- both theoretical and analytical -- commonly used to de- scribe and analyze interaction phenomena that occur in the real world. Social ties formation, economic transac- tion, face to face communication, the unfolding of human mobility are a few examples of observable events that are often investigated using instruments borrowed from Graph Theory. One main issue to address while studying such kind of real-world events lies in the identification of meaningful substructures hidden within the overall complex system. How to partition a complex network into communities is a widely studied problem (Coscia et al., 2011; Fortunato, 2010): several works, from a broad set of disciplines, proposed different community definitions and approaches able to retrieve such structures automatically. The mag- nitude of papers that cover this fascinating topic high- lights its ubiquity: communities can capture groups of strongly connected online documents, individuals sharing a social environment as well as products being frequently purchased together. Most of the scientific literature dedicated to the com- munity discovery problem start from a very stringent as- sumption: real-world phenomena can be modeled with static networks, i.e., mathematical objects "frozen" in time. Unfortunately, such simplified scenario seldom fits the evolving nature of the world we live in. Indeed, one of the key features that characterize interaction phenomena is that they naturally unfold through time: social interac- tions evolve, phone calls have a limited duration, human mobility changes as time goes by. The temporal dimen- sion conveys highly valuable information that the analyst needs to exploit to better understand the reality he/she observes. The need to include such knowledge in the tools offered by graph theory has been one of the linchpins in an entirely new field of investigation that emerged in the last decade: dynamic network analysis. Within this new field, well-known problems defined in static settings were reformulated, and time-aware approaches able to solve them were proposed. Amongst them, Dynamic Community Discovery (henceforth also referred as DCD) represents one of the most challenging problems. As time goes by, nodes and edges can join and leave a dynamic network, producing relevant perturbations on its topology: communities are the basic bricks of that complex structure and, as such, are profoundly affected by local changes. While classical community discovery algorithms aim to identify hidden substructures, dynamic approaches are devoted to the tracking of such local topologies and of their mutations, a goal that can be fulfilled pursuing different strategies and modeling choices. In this survey, we have thus chosen to design a taxon- omy of DCD algorithms not by considering the technical solution they use to find them, but rather the strategy they use to identify time-aware meaningful network sub- structures. Our aim is to support researchers and ana- lysts in choosing the approach, or at least the class of approaches, that better fits their needs and data. For each of the proposed classes of DCD algorithms we dis- cuss both advantages and drawbacks. Moreover, we pro- vide a brief description of those methods that implement their rationale. To provide a comprehensive view of this field of re- 2 search, we also discuss issues related to the evaluation of DCD algorithms, which requires modifications compared with the static case; moreover, we summarize other works on DCD, such as dynamic community visualization meth- ods, and analytical applications to real-world problems. The survey is organized as follows. In Section II, we discuss the general concepts behind dynamic network analysis and the mathematical models used to describe, in graph theoretical terms, temporal evolving phenom- ena. In Section III, we formalize the Community Dis- covery problem on Dynamic networks and discuss com- munity life-cycle and instability. In Section IV, we in- troduce our DCD taxonomy describing the peculiarity, pros, and cons of each class of approaches. A detailed description of the methods is then made available in the Appendix. In Section V we introduce and discuss two classes of techniques often used to compare and charac- terize communities identified by DCD algorithms, namely internal and external quality evaluation. In Section VI we review some real-world scenarios that have been stud- ied through the lenses of dynamic community mining and address the problem of visualizing analytical results. Fi- nally Section VII concludes the survey, providing insights into DCD related open issues. II. DYNAMIC NETWORKS Since its beginning, complex network analysis has been approached by researchers through the definition of very specific mining problems. Among them community dis- covery (Coscia et al., 2011; Fortunato, 2010), link-based object ranking (Duhan et al., 2009; Getoor and Diehl, 2005), frequent pattern mining (Alon, 2007; Milo et al., 2002) are examples of analytical tasks originally defined on networks "frozen in time". The absence of the time dimension comes from histor- ical reasons: the graph theory ancestry of the field, and the scarcity of existing dynamic data at the time the field of complex networks emerged. With the explosion of human-generated data, often collected by socio-technical platforms, more and more datasets having rich temporal information that can be studied as dynamic networks becomes available. Many works tried to transpose well-known graph mining prob- lems from static networks to temporal networks: Tempo- ral motifs mining (Kovanen et al., 2011), Diffusion (Lee et al., 2012), Link prediction (Tabourier et al., 2016), etc. To better address the central topic of this survey, we first introduce in Section II.A the most used formalisms to represent dynamic networks and, subsequently in Sec- tion II.B, we discuss one of the leading issues arising when dealing with temporally annotated networks: net- work memory. A. Network Models Time plays a crucial role in shaping network topolo- gies. One of the most important issue to address in order to reason on time evolving networks is thus re- lated to the mathematical formalism used to describe them. In Figure 1 are shown four different conceptual FIG. 1 Network representations. Moving from static graph to interaction ones the model complexity increases while the grain of the temporal information available decreases (Ros- setti, 2015). solutions that gradually introduce the temporal dimen- sion in the network modelling process. At one hand we find the complete atemporal scenario (i.e., a single net- work snapshot capturing a static glimpse of a dynamic phenomenon): network dynamics can be gradually intro- duced by adopting labels that weights nodes and edges, thus capturing an aggregate network. Following this ap- proach, weights models the number of occurrence of a given node/edge in a pre-determined observation win- dow: with this little increment in the model complex- ity, several time-dependent analysis neglected before be- come possible (i.e., tie strength estimation). Aggregation strategies, however, suffer a severe limitation, they do not capture dynamics. For this reason several works model dynamic phenomena with temporally ordered series of network snapshots. This simple modeling choice allows to efficiently keep track of the perturbations occurring on the network topology. However, while the expressiv- ity of the model is increased, the analytical complexity increases as well. When dealing with network snapshots to perform time-aware mining tasks, two issues need to be addressed: (i) how to keep track of multiple stages of the network life and (ii) how to harmonize the analyti- cal results obtained in a snapshot with the outcome of subsequent ones. Dynamic network partition, as well as aggregation, suf- fers from a pressing issue: to be performed, a tempo- ral granularity -- a threshold to transform the original dynamic system -- needs to be fixed. Since the identi- fication of such threshold is not trivial -- it is, indeed, context-dependent and often profoundly impacts analyt- ical results -- recent works propose to model dynamic phe- nomena without any aggregation, keeping all temporal details. Such studies usually decompose a dynamic net- work in its elementary bricks: temporally ordered, times- tamped, interactions or relations. We will describe in more details such approach, namely temporal networks modeling, in the next section. Temporal networks, avoiding aggregation, allow for a complete and fine-grained description of network dynam- 3 ics: as a drawback, this solution increases the complexity of the network model and requires the definition of novel analytical methodologies. Different problems, as well as available data, impose different modeling choices: static network, as well as weighted ones, are often used to identify stable patterns and to describe the actual status of a network while snap- shots and interactions are proxies for the study of increas- ingly dynamic scenarios. Obviously, starting from fine- grained temporal data, it is possible to generate all the other models by subsequent aggregations. Since we are interested in community detection approaches that deals with temporally annotated graphs, in the following we will highlight the major strengths and drawbacks of the most used models in this context: Temporal Networks and Network Snapshots. In this survey, we will not discuss static and weighted networks since, by definition, they do not allow to make direct use of temporal informa- tion, thus reducing dynamic problems to static ones: for an in-depth overview of community discovery approaches defined for such scenarios refer to (Coscia et al., 2011; Fortunato, 2010; Fortunato and Hric, 2016; Xie et al., 2013b). 1. Temporal Networks Several formalisms have been proposed to represent evolving networks without loss of information: Tempo- ral Networks (Holme and Saramaki, 2012), Time-Varying Graphs (Casteigts et al., 2012), Interaction Networks (Rossetti et al., 2015), Link Streams and Stream graphs (Latapy et al., 2017; Viard et al., 2016), to name the most popular. Hereafter, we use the term Temporal Networks, with a general definition that encompasses all those for- malisms. A Temporal Network models a dynamic structure in which both nodes and edges may appear and disappear as time goes by, more formally: Definition 1 (Temporal Network) A Temporal Net- work is a graph G = (V, E, T ) where: V is a set of triplets of the form (v, ts, te), with v a vertex of the graph and ts, te ∈ T are respectively the birth and death timestamps of the corresponding vertex (with ts ≤ te); E is a set of quadruplets (u, v, ts, te), with u, v ∈ V are vertices of the graph and ts, te ∈ T are respectively the birth and death timestamps of the corresponding edge (with ts ≤ te). Depending on the interaction semantics, we can deal with undirected Temporal Networks (TN) or with Directed Temporal Networks (DTN). The high-level definition proposed encompasses nodes and edges with or without duration (if ts = te). Often, a strong distinction is made between those two categories. Networks without edges durations are often referred as contact sequences, those with durations as interval graphs StaticEdge WeightedSnapshotsTemporal NetworksModel complexityTemporal impact (Holme and Saramaki, 2012). We argue that, for com- munity detection, this distinction is not relevant to char- acterize the nature of temporal networks. Indeed, a con- tact sequence can always be transformed into an inter- val graph by extending edges of an infinitesimal amount. Conversely, an interval graph can be discretized into a contact sequence at the desired resolution. However, such transformations will not fundamentally change the na- ture of the network. or not (emails, short messages, etc.) Differently, a distinction must be made between two types of temporal networks, interaction networks and relation networks: the former model interactions either with duration (phone calls, face to face communication, etc.) that can repeat as time goes by. Relation networks, conversely, model more stable relations (friendship, co-worker, be- longing to the same group, etc.). In relation networks, the state of the graph at any given time is well-defined and can be studied through classical static analysis tools. Conversely, in interaction networks, the analyst needs to focus his attention on a temporal windows or on aggre- gations of some sort to obtain a stable dynamic graph that does not change dramatically between close time- periods. This distinction is important since many meth- ods -- in particular the ones working on edge streams -- update the state of communities after each atomic net- work perturbation. Indeed, classical approaches do not produce interpretable results when edges are instanta- neous or have very low persistence (e.g., phone calls). Due to the lack of literature, and in particular of a for- mal definition able to distinguish between these two types of temporal networks, in this article we have no choice but to ignore this distinction. We stress that most al- gorithms present in the current survey implicitly assume a relation network, save three methods (Himmel et al., 2016; Matias et al., 2018; Viard et al., 2016), specifically designed to work with edges without duration. 2. Network Snapshots Often, network history is partitioned into a series of snapshots, each one of them corresponding either to the state of the network at a time t (relation network) or to the aggregation of observed interactions during a period (interaction network). Definition 2 (Snapshot Network) A Snapshot Graph Gτ is defined by an ordered set (cid:104)G1, G2 . . . Gt(cid:105) where each snapshot Gi = (Vi, Ei) is univocally identified by the sets of nodes Vi and edges Ei. Depending on the network semantic, we can deal with undirected Snapshot Graphs (SN) or with Directed Snap- shot Graphs (DSN). Dynamic networks represented us- ing snapshots are similar in nature to multiplex (or mul- tislice) networks, which are unordered sets of static networks. To learn more on community detection on multislice networks, readers can refer to (Kivel et al., 4 2014). When the adaptation of methods to the dynamic case have been explored, methods will be included in the present article, see for instance (Mucha et al., 2010). Network snapshots can be effectively used, for in- stance, to model a phenomenon that generates network perturbations (almost) at regular intervals. In this sce- nario, context-dependent temporal windows are used to partition the network history into consecutive snapshots: time-bounded observations describing a precise, static, discretization of the network life. The snapshot-based analysis is frequently adopted for networks having a natural temporal discretization, due to the balance they propose between model complexity and expressivity. SN allow to apply static networks tools on evolving networks. Algorithms, as well as network measures and definitions, can be independently applied to each temporal partition without the need of novel ana- lytical tools that explicitly manage temporal information. SN can also be seen as a convenient modeling choice to avoid the instability problem of temporal networks, us- ing aggregation over periods of times and sliding windows (Morini et al., 2017). However, the strength of this model represents also its major drawback. Even if network snapshots reduce the analytical complexity and allow for task paralleliza- tion, they intrinsically imply the need for a reconciliation phase in which the independently computed, partial re- sults are combined. The need for two-step (mining and reconciliation) procedures can often be the cause of the quality degradation of analytical results. Another issue related to the SN model is the identification of the opti- mal window size to use when generating the snapshots, a choice that can profoundly affect the outcome of the subsequent analysis. 3. Discussion: Temporal Networks vs. Snapshots An important issue to address is the relation between Snapshot and Temporal Networks since, as we will see in Section IV, a generic DCD algorithm is usually tailored to exploit only one of such representations. The differ- ences among TN and SN are tightly connected to the constraints such models impose: the choice of employing TN instead of SN (or vice versa) can have significant im- plication on aspects related to the storage of data, and the processing part of the designed analysis. In particu- lar: a) If the original data already describe punctual states of the network evolution (for instance, a weekly/monthly/yearly complete crawl of a sys- tem), the snapshot model is obviously the natu- ral one to adopt. On the contrary, if a more pre- cise temporal information is available (for instance an e-mail, a friend list or phone call dataset with timestamps of finite precision), both solutions can be considered. b) Since, unlike TNs, SNs are composed of aggregated data, the typical complexity of processes on a SN depends on the chosen level of aggregation, and on the sizes of the produced snapshots (number of nodes/edges). For instance, methods for DCD on SN typically need to run a community detection process on each snapshot. The cost of running a Community Discovery algorithm at t + 1 typically does not depend on the number of changes between SN at t and t + 1. Processes running on TNs, on the contrary, typically depend mainly on the num- ber of network modifications, not on the granularity or the total number of nodes. B. Network Memory A modeling choice that profoundly affects the analy- sis performed on dynamic networks regards the system memory. When the analyzed data describe an interac- tion network (for instance, e-mails or phone calls), not composed of long-lasting relations, most methods require to transform it into a relation network, i.e., to assign to each edge a duration appropriate to consider it as rela- tion network. Such transformation can yield snapshots (if synchronized) or temporal networks (if each edge du- ration computation is done independently). Two main scenarios are often considered: (i) perfect memory network (or accumulative growth scenario) and (ii) limited memory network. In the former scenario nodes and edges can only join the network: the dynamic network has a perfect memory meaning that old edges/nodes cannot disappear (e.g., a citation graph). Conversely, in the latter, nodes/edges can vanish as time goes by (i.e., in a social network con- text, edge disappearance can be used to model the decay of interactions' social effect). We call Time To Live (TTL) the artificially defined duration of an edge. Several strategies exist to fix this TTL: • fixed size static time window : the TTL is equal for all network entities, and there is a finite set of pos- sible periods whose start and end dates are defined in advance. This strategy produces snapshot net- works. • fixed size sliding time window : the TTL is equal for all network entities, but it starts independently for each one of them at the moment of their first ap- pearance (i.e., an email graph in which each email is considered to have the same social persistence starting from the time it is made); • dynamic size time window : the TTL is equal for all the network entities at a given time but depends on the current network status (i.e., a system for which it is interesting to capture bursts of interactions having different frequency); 5 • (global/local) decay function: the TTL of each node/edge is defined independently, usually as a function of the global/local network activity (i.e., fitting the inter-arrival time distribution of nodes or edges for the whole network as well as for the individual node pair). The assumptions made on the persistence of network en- tities (e.g., the strategy identified to fix their TTL) play a crucial role in the results provided by time-aware mining algorithms. III. DYNAMIC COMMUNITY DISCOVERY As discussed in the previous section, the temporal di- mension profoundly impacts the analytical tasks that are commonly performed on complex networks. Among them, a problem that has always received high atten- tion from the scientific community is community discov- ery (henceforth, CD). Networks built on real-world data are complex objects often composed of several substruc- tures hidden in an apparent chaos: community discovery aims to decompose them in meaningful sub-topologies that better describe local phenomena. Even though the problem itself is intuitively clear, its formulation is partic- ularly ill-posed: given a specific network, different par- titions can exist, each of them capturing different but valuable information. In the last decades, we have wit- nessed the proliferation of an extensive literature on such subject, each work proposing its approach optimizing the partition for a different quality function (i.e., mod- ularity, density, conductance, cut. . . ), thus making the comparison between different partitions challenging. The widespread of different community definitions lead to a renewed awareness: the perfect Community Discovery Algorithm does not exist. Conversely, there exist a set of algorithms that better perform on a specific declination of the general problem. In this section, we formally define the community dis- covery problem on dynamic graphs (Section III.A) and describe how its solutions can be used to study commu- nity life-cycle (Section III.A.1). Moreover, we discuss two relevant topics related to this complex problem: commu- nity instability and temporal smoothing (Section III.B). A. Problem Definition Community discovery is a typical problem in complex network analysis. One of the main reason behind its com- plexity is undoubtedly related to its ill-posedness. In- deed, several community definitions were proposed so far. Classic works intuitively describe communities as sets of nodes closer among them than with the rest of the net- work, while others, looking at the same problem from another angle, only define such topologies as dense net- work subgraphs. To maintain a more general perspective, in this survey we will adopt a meta-definition -- borrowed from (Coscia et al., 2011) -- to create an underlying con- cept able to generalize to all the variants found in the literature (verbatim from (Coscia et al., 2011)): Definition 3 (Community) A community in a com- plex network is a set of entities that share some closely correlated sets of actions with the other entities of the community. We consider a direct connection as a partic- ular and very important, kind of action. Given the high-level nature of the adopted problem definition, one could prefer the term of "node clustering" over community detection. Due to the lack of consensus in the literature, we choose to keep the term communi- ties that is specific to the field of networks mining and analysis. Once fixed the definition of community, we can for- mally define the specific task of identifying and track- ing mesoscale structures in a dynamic network scenario. Even in this case, we adopt a generic definition, that does not make any assumption about the nature of com- munities, and that correspond to any dynamic cluster of nodes. Definition 4 (Dynamic Community Discovery) Given a dynamic network DG, a Dynamic Community DC is defined as a set of distinct (node, periods) pairs: DC = {(v1, P1), (v2, P2), . . . , (vn, Pn)}, with Pn = ((ts0, te0), (ts1, te1) . . . (tsN , teN )), with ts∗ ≤ te∗. Dynamic Community Discovery aims to identify the set C of all the dynamic communities in DG. The partitions described by C can be neat as well as overlapping. Within this general definition fall approaches having different goals. In particular, two main analytical aims can be identified: (i) enable for an efficient identification of optimal partitions for each instant of the evolution and, (ii) build evolutive chains describing the life-cycle of communities. 1. Community Life-Cycle The persistence along time of communities subjected to progressive changes is an important problem to tackle. As illustrated by the famous paradox of the ship of The- seus, deciding if an element composed of several entities at a given instant is the same or not as another one com- posed of some -- or even none -- of such entities at a later point in time is necessarily arbitrary, and cannot be an- swered unambiguously. Most works focused on community tracking agree on the set of simple actions that involve entities of a dynamic network: node/edge appearance and vanishing. Indeed, such local and atomic operations can generate perturba- tions of the network topology able to affect the results produced by CD algorithms. As a consequence of this set of actions, given a community C observed at differ- ent moments in time, it is mandatory to characterize the 6 transformations it undergoes. A first, formal, catego- rization of the transformations that involve communities were introduced in (Palla et al., 2007), which listed six of them (Birth, Death, Growth, Contraction, Merge, Split). A seventh operation, "Continue", is sometimes added to these. In (Cazabet and Amblard, 2014), an eighth oper- ation was proposed (Resurgence). These operations, illustrated in Figure 2, are the fol- lowing: • Birth: the first appearance of a new community composed of any number of nodes; • Death: the vanishing of a community: all nodes be- longing to the vanished community lose this mem- bership; • Growth: new nodes increase the size of a commu- nity; • Contraction: some nodes are rejected by a commu- nity thus reducing its size; • Merge: two communities or more merge into a sin- gle one; • Split: a community, as consequence of node/edge vanishing, splits into two or more components; • Continue: a community remains unchanged; • Resurgence: a community vanishes for a period, then comes back without perturbations as if it has never stopped existing. This event can be seen as a fake death-birth pair involving the same node set over a lagged time period (example: seasonal be- haviors). Not all operations are necessarily handled by a generic DCD algorithm. Even though the abstract semantics of such transformations are clear, different works propose to handle them differently. Among them, Merge, Split and Resurgence are often defined with the support of ad-hoc similarity and thresholding functions as well as commu- nity transformation strategies. For instance, when two communities are chosen to be merged, several strategies can be followed to handle the Merge action (Cazabet and Amblard, 2014): • Absorption: after the Merge, one community dis- appears while the other persists. In this sce- nario, defining a policy to decide which commu- nity will cease to exist is an open issue. Among possible choices, we can cite: (i) Remove the old- est/youngest one; (ii) Remove the biggest/smallest one; (iii) Remove the community with the highest percentage of nodes included in the other. • Replacement: after the Merge action, affected com- munities vanish, and a wholly new one forms. This solution, although straightforward, causes sudden disruptions on the continuity of the evolution of communities. 7 FIG. 2 Community events. This toy example captures the eight events that regulates dynamic community life. In the first row Birth and Death; in the second row Growth and Contraction; in the third row Merge and Split; in the fourth row Continue; in the last row Resurgence. GrowthContractionMergeSplitBirthDeathContinuett+nt+n-1t+1Resurgence Such complex scenario symmetrically applies to the specific implementation of all the remaining community actions. Despite the peculiarities introduced by each approach when defining topology transformations, the identified events allow to describe for each community its so-called life-cycle (an example shown in Figure 3): Definition 5 (Community Life-cycle) Given a com- munity C, its community life-cycle (which univocally identifies C's complete evolutive history) is composed of the Directed Acyclic Graph (DAG) such that: (i) the roots are Birth events of C, and of its potential predecessors if C has been implicated in Merge events; (ii) the leafs are Death events, corresponding to deaths of C and of its successors, if C has been implicated in Split events; (iii) the central nodes are the remaining actions of C, its suc- cessors, and predecessors. The edges of the tree represent transitions between subsequent actions in C life. In principle, it is possible to perform a life-cycle analy- sis starting from the output of any generic dynamic com- munity discovery approach. B. Community Instability & Temporal Smoothing One of the main issues encountered by dynamic com- munity detection approaches is the instability of solu- tions. Such problem comes from the very nature of com- munities. It is widely accepted that there is not a single valid de- composition in communities of a complex network issued from field data but, instead, several possible ones. More- over, most algorithms generate partitionings in which a node is assigned unambiguously to one and only one com- munity. Indeed, we are aware that such scenario rep- resents a simplification: nodes often belong to several communities, and the belonging to each of them is not necessarily binary (as illustrated by fuzzy partitions ap- proaches). Another issue is that the choice between one partition and another is somewhat arbitrary: moreover, a generic algorithm executed on the same network that experienced a few topological variations -- or even none in case of stochastic algorithms -- might lead to different re- sults. To take a concrete example, if the problem of find- ing the solution of optimal modularity in a network is so complex, it is because many local maxima exist, whose modularity values are very close from the optimal one. Greedy approaches such as the Louvain method (Blon- del et al., 2008) can find a local maximum; however, a slight variation of the initial network might switch from one local maximum to another, yielding significantly dif- ferent partitions, both comparable in term of modularity score. All such observations naturally lead to the general problem of identifying stable network decompositions. This is a major problem for dynamic community detec- tion, as one cannot know if the differences observed be- 8 tween communities found on the network at time t and those found at t + 1 are due to the evolution of commu- nities or to the algorithm's instability. This problem has been explored in (Aynaud and Guil- laume, 2010). The authors picked three well-known static community detection algorithms (WalkTrap (Pons and Latapy, 2006), Louvain (Blondel et al., 2008), and Fast Greedy modularity (Clauset et al., 2004)), and evaluated the consistency of their results on slight modifications of a network. To do so, they compare the modularity (Newman, 2004; Newman and Girvan, 2004) and Nor- malized Mutual Information (NMI (Lancichinetti et al., 2008)) scores between successive results, and quantify the number of transformations between two consecutive runs (where a transformation is the change in affiliation of a node). The results revealed the extent of the problem: on a network composed of 9377 nodes and 24107 edges, constructed from a co-authorship network, the removal of a single node leads to NMIs between successive results of -- respectively to each algorithm -- 0.99, 0.9 and 0.75. The result is even more striking when looking at the number of unitary change: a single node modification leads re- spectively to approximately 500, 2000 and 3000 unitary change in communities. A variety of solutions has been proposed to solve, or at least mitigate, this instability problem. Their common goal is to smooth-out the evolution of commu- nities. Among them, we can identify the following main categories: smoothing by bootstrap, explicit smoothing, implicit smoothing and global smoothing. Smoothing by bootstrap. This technique (used in particular in (Hopcroft et al., 2004; Rosvall and Bergstrom, 2010)) consists of running multiple times the same algorithm on the same static network, searching for invariants, stable parts of the communities. The stable community cores, less unstable than raw community partitions, can be more efficiently tracked. Explicit smoothing. Some algorithms (e.g., (Folino and Pizzuti, 2014; Lin et al., 2009)) explicitly introduce smoothing in their definition, requiring the partition found at step t to have a certain degree of similarity with the partition found at t − 1. These methods typically introduce a parameter α ∈ [0, 1], that determines the trade-off between a solution that is optimal at t and a solution maximizing the similarity with the result at t−1. Implicit smoothing. Some methods do not ex- plicitly integrate the similarity between consecutive partitions but favor this similarity by construction. We can distinguish between two main scenarios to do so: 1. Methods that optimize a global metric, such as the modularity, can use the communities found at the previous step as seeds for the current one (e.g., (Gorke et al., 2010; Shang et al., 2014)). The proba- bility of finding similar solutions from step to step is increased by choosing an adequate algorithm, that 9 FIG. 3 Community Life-cycle. As time goes by, dynamic communities experience mutations that are often abstracted by adopting a predefined set of operations. This toy example highlights life-cycles of communities A and C, composed of all the operations that modify a community structure, namely: birth, continue, growth, split, merge, contraction, resurgence, death. will explore in priority good solutions around seeds. IV. CLASSIFICATION 2. Other approaches (e.g., (Cazabet et al., 2010; Ros- setti et al., 2017; Xie et al., 2013a)) do not try to optimize a global metric but update locally com- munities that have been directly affected by modi- fications between the previous and the current step. In this case, the solution at step t − 1 is kept un- changed, but for communities directly affected by changes in the network. In a slowly evolving graph, this guarantees that most of the partition stays identical between two evolution steps. Global smoothing. Instead of smoothing communities at a given step by considering the previous one, algo- rithms (e.g., (Aynaud and Guillaume, 2011; Mucha et al., 2010)) can search for communities that are coherent in time by examining all steps of evolution simultaneously. Such strategy can be applied, for instance, by creating a single network from different snapshots by adding links between nodes belonging to different snapshots and then running a community detection on this network. Another way to pursue in this rationale is to optimize a global metric on all snapshots simultaneously. In both cases, the problem of instability naturally disappears, as the detection of dynamic communities is performed in a single step. indeed, the decision to When designing a DCD algorithm, adopt a specific smoothing strategy has non-negligible impacts: it can leads to computational con- straints, narrows the applicative scenarios as well as impacts results it will be able to provide. For all those reasons, in Section IV we describe a novel two-level taxonomy that exploits a characteristic of smoothing to discriminate among different classes of dynamic community discovery approaches. In this Section, we propose a classification, summa- rized in Figure 4, of Dynamic Community Discovery methods. Three previous works, to the best of our knowledge, have proposed a classification of DCD algorithms, al- though considering much fewer methods that the current survey. In (Aynaud et al., 2013), identified classes are: • Two-Stage approaches, methods that first detect clusters at each time step and then match them across different time-steps; • Evolutionary Clustering, methods that detect com- munities at time t based on the topology of the graph at t and on previously found community structures; • Coupling graphs, algorithms that first construct a single graph by adding edges between instances of nodes in different time-steps (coupling graph), and then run a classic CD on this graph. Two-Stage approaches are then further divided into Core based, Union Graph based and Survival Graph based methods, corresponding to different solutions to solve the problem of graph matching. In (Hartmann et al., 2016), two high level categories are identified, Online and Offline methods. The survey focuses only on Online algorithms, defined as methods that explicitly exploit information about the graph struc- ture and the community structure of previous time steps, as opposed to Offline ones that also use information from following time steps. Online methods are divided in: • Temporal Smoothness methods that run a CD pro- cess from scratch at each step; • Dynamic update methods that do not run a process from scratch but instead update the methods found in previous time steps. ABACDACD01234timeBirthBirthBirthMergeSplitContinueResurgenceDContractionGrowth5ADeath6Death 10 FIG. 4 Proposed classification for DCD algorithms. There are three high-level classes, corresponding to different dynamic community definitions. Each of these classes is divided into subcategories, corresponding to different manners to solve a similar problem. These first two classifications are complementary, and somewhat overlapping: Coupling graphs methods are Of- fline, but some Two-Stage approaches can also be Of- fline, since they match communities across all time-steps. Two-stage approaches are a special case of Temporal Smoothness without memory, while Evolutionary Clus- tering methods encompass both Temporal Smoothness and Dynamic update methods. Finally, in (Masuda and Lambiotte, 2016), the authors identify two different typologies of community discovery approaches in temporal networks: • Approaches focused on determining Community evolution that, with certain statistical accuracy, aim to detect when and how reorganisations of com- munities take place. In this family fall the two-stage as well as model-based approaches. • Single community structure methods whose goal is to find a single partition of the dynamic graph by considering time as a third dimension of the data, added to the classical two expressed by the adja- cency matrix. Among them fall the Tensor fac- torization approaches like the one introduced in (Gauvin et al., 2014), where a single partition is identified and the strength of each community per temporal snapshot is computed. Some methods we found in the literature were not be- longing to any of these categories or could be associated with several of them. We decided to shape our classification as a two-level one, building it upon concepts shared by existing classi- fications. In our taxonomy, the higher level identifies three differ- ent definitions of what are Dynamic Communities, with- out assumptions on the techniques used to find them. These high-level classes are then refined into subcate- gories, which correspond to different techniques used to find communities corresponding to this definition. There are three classes of approaches at the higher level of classification: • The first one (Instant-optimal CD) considers that communities existing at t only depend on the cur- rent state of the network at t. Matching commu- nities found at different steps might involve look- ing at communities found in previous steps, or con- sidering all steps, but communities found at t are considered optimal, w.r.t. the topology of the net- work at t. Approaches falling in this class are non- temporally smoothed. • In the second class (Temporal Trade-off CD), com- munities defined at an instant t do not only depend on the topology of the network at that time, but also on the past evolutions of the topology, past partitions found, or both. Communities at t are therefore defined as a trade-off between optimal so- lution at t and known past. They do not depend on future modification, an important point for "on the fly" CD. Conversely, from the approaches falling in the previous class, Temporal Trade-off ones are in- crementally temporally smoothed. • In the third class (Cross-Time CD), the focus shifts from searching communities relevant at a particu- lar time to searching communities relevant when considering the whole network evolution. Methods of this class search a single partition directly for all time steps. Communities found at t depends both on past and future evolutions. Methods in this class produce communities that are com- pletely temporally smoothed. Dynamic Community DiscoveryTemporal Trade-offInstant OptimalCross-TimeIterative Similarity BasedIterative Core-Node BasedUpdate by Global Optimization Update by Set of RulesInformed CD by Network Smoothing Informed CD by Multi-Objective Optimization Fixed Memberships, Fixed PropertiesEvolving Memberships, Evolving PropertiesEvolving Memberships, Fixed PropertiesFixed Memberships, Evolving PropertiesMulti-StepMatching 11 For each of these classes, we define subcategories, corre- sponding to different techniques used to solve a related problem. In the following we address each one of them, discussing their advantages and drawbacks. As we will highlight in the following, each class -- due to its defi- nition -- is likely to group together approaches designed to work on either Network Snapshots (SN) or Temporal Networks (TN). Please note that to keep our classification concise, we do not include the description of each method here. We provide a short description of methods included in each category in the Appendix. Drawbacks: The main limit of this approach is the instability of community detection algorithms (see Section III.B for more details on instability). Since the same algorithm can find different communities on the same network, it is hazardous to distinguish between changes due to the evolution of the community structure and changes due to the instability of algorithms. Recent approaches propose solutions to circumvent this weak- ness, by studying the most stable part of communities, called community cores (Rosvall and Bergstrom, 2010), or by considering all partitions simultaneously, instead of matching only with earlier ones (Goldberg et al., 2011). A. Instant-optimal Communities Discovery This first class of approaches is derived directly from the application of static community discovery methods to the dynamic case. A succession of steps is used to model network evolution, and for each of them is identi- fied an optimal partition, as shown in Figure 5. Dynamic communities are defined from these optimal partitions by specifying relations that connect topologies found in dif- ferent, possibly consecutive, instants. A typical Instant-optimal technique has been identified as Two-Stage Approach in the literature (Aynaud et al., 2013). It can be described as a two steps process: 1. Identify: detect static communities on each step of evolution; 2. Match: align the communities found at step t with the ones found at step t − 1, for each step. It can be noted however that Two-Stage Approaches and Instant-optimal communities do not encompass the same methods: indeed, two-stage techniques can be used with communities smoothed-out using previous communities, and therefore not Instant-optimal. On the contrary, some methods find instant-optimal communities but match these communities considering all partitions simultaneously, instead of using an iterative process. In the following, we discuss the advantages and drawbacks of this class of algorithms, and the dynamic network models it can be applied to. Advantages: The major benefit of adopting this approach is that it is built directly on top of existing works on static community detection. Since commu- nities are Instant-Optimal, usual DC algorithms can be used at each step. The matching process can also be derived from existing literature since set matching is an extensively studied problem. Another advantage of this method is that it easily enables parallelization. Community detection can be a time-consuming process on large networks, and since the communities at each step are found independently, it is possible to run the detection at each step in parallel. Network models: Due to its definition, algorithms that fall in this class can be used only with Network Snapshots, not with Temporal Networks. As the com- munity detection needs to be performed entirely from scratch at each evolution step, the whole network needs to be considered, not only the changes between one step and another. Subcategories: The first step of the process, iden- tifying communities relevant at each time step, can usually be done with any CD algorithm. However, the methods used to match communities found at different steps differ. We identified three subclasses: (i) Iterative similarity-based (ii) Iterative core-based (iii) Multi-step matching. 1. Iterative similarity-based approaches In similarity-based approaches, a quality function is used to quantify the similarity between communities in different snapshots (e.g., Jaccard among node sets). Communities in adjacent time-steps having the highest similarity are considered part of the same dynamic com- munity. Particular cases can be handled, such as a lower threshold of similarity, or the handling of 1 to n or n to n matchings, thus defining complex operations such as split and merge. Methods in this subcategory: (B´ota et al., 2011; Bourqui et al., 2009; Br´odka et al., 2013; Dhouioui and Akaichi, 2014; Greene et al., 2010; Hopcroft et al., 2004; Ilhan and Oguducu, 2015; Palla et al., 2007; Rosvall and Bergstrom, 2010; Takaffoli et al., 2011). Refer to Appendix VIII.A for methods description. 2. Iterative Core-nodes based approaches Methods in this subcategory identify one or several special node(s) for each community -- for instance those with the highest value of a centrality measure -- called core-nodes. Two communities in adjacent time-steps containing the same core-node can subsequently be iden- tified as part of the same dynamic community. It is thus possible to identify splits or merge operations by using 12 FIG. 5 Instant Optimal. The identification of dynamic communities is conceptually decomposed in two subproblems: (i) independent extraction of the network partition for each time step, and (ii) matching of communities belonging to distinct network observations. Legend: G: Graph, P: Partition, DC: Dynamic Community, C: Community several core-nodes for a single community. Methods in this subcategory: (Chen et al., 2010; Wang et al., 2008) Refer to Appendix VIII.B for methods description. 3. Multi-step matching Methods in this subcategory do not match communi- ties only between adjacent time-steps. Conversely, they try to match them even in snapshots potentially far apart in the network evolution. The matching itself can be done, as in other sub-categories, using a similarity mea- sure or core-nodes. The removal of the adjacency con- straint allows to identify resurgence operations, i.e. a community existing at t and t + n but not between t + 1 and t + (n − 1). It can, however, increase the complex- ity of the matching algorithm, and on-the-fly detection becomes inconsistent, as past affiliations can change. Methods in this subcategory: (Falkowski et al., 2006; Falkowski and Spiliopoulou, 2007; Goldberg et al., 2011; Morini et al., 2017) Refer to Appendix VIII.C for methods description. B. Temporal Trade-off Communities Discovery Algorithms belonging to the Temporal Trade-off class process iteratively the evolution of the network. More- over, unlike Instant optimal approaches, they take into account the network and the communities found in the previous step -- or n-previous steps -- to identify commu- nities in the current one. DCD algorithms falling into this category can be described by an iterative process: 1. Initialization: find communities for the initial state of the network; 2. Update: for each incoming step, find communities at step t using graph at t and past information. As for the Instant-optimal class, this template, ex- emplified in Figure 6, can be implemented by several typologies of approaches. In the following we discuss its advantages and drawbacks, and the dynamic network models it can be applied to. Advantages: Temporal Trade-off approaches allow to cope with the instability problem that affects Instant-optimal ones (see Section III.B), while not diverging much from the usual community detection definition (a partition is searched-for at each step). Most methods of this class take advantage of the existing community structure at step t − 1 to speed up the community detection at t. In the general case, Drawbacks: it is not possible to easily parallelize the community detection, as each step needs the communities found at the previous ones issue is the long-term as input. Another potential coherence of dynamic communities. Since at each iteration the identified partition depends on previous ones, Temporal Trade-off approaches are subject to the risk of an avalanche effect: communities can experience substantial drifts compared to what a static algorithm would find on the static network corresponding to the state of the system at a given time. Network Models: This algorithmic schema has been used with both dynamic networks representations introduced in Section II.A. When using Temporal Net- works, only the incremental modifications of the network are considered to make the communities evolve, usually using local rules. Conversely, when using Network Snapshots, a process is usually run on the whole graph, as for a static algorithm, but taking into account past information. Subcategories: The Temporal Trade-off template can be satisfied by very different algorithmic approaches. Among them, we identified four subcategories. The first two, namely Update by Global Optimization and Update by a set of rules, consist in updating the partition found at the previous step, using global or local P1G t1G t2...G tnP2Pn DiscoveryMatchingt1C1t1C2...t1Cnt2C1t2C2...t2CntnC1tnC2...tnCn ResultDC1 t1C1 t1C2... tnCnDCn t1C2 t2C1... tnCn... 13 FIG. 6 Temporal Trade-off. After a bootstrap phase, communities are found iteratively at each step by exploiting information gathered from previous networks statuses and partitions. Legend: G: Graph, P: Partition, DC: Dynamic Community, C: Community approaches. The last two, namely Informed CD by Multi-objective Optimization and Informed CD Network Smoothing, run a community detection from scratch for each snapshot while considering previous steps information. 1. Update by Global Optimization Methods in this subcategory: (Agarwal et al., 2012; Cazabet and Amblard, 2011; Cazabet et al., 2010; Duan et al., 2012; Falkowski et al., 2008; Gorke et al., 2012; Lee et al., 2014; Ma and Huang, 2013; Nguyen et al., 2011a,b; Rossetti et al., 2017; Xie et al., 2013a; Zakrzewska and Bader, 2015) Refer to Appendix IX.B for methods description. A popular method for static CD is to optimize a Global Quality Function, such as Modularity or Conductance. 3. Informed CD by Multi-objective optimization This process is typically done using a heuristic (gradi- ent descent, simulated annealing, etc. . . ) that iteratively merges and/or splits communities, and/or moves nodes from a community to another until a local or global max- imum is reached. Methods in this subcategory use the partition existing at t as a seed to initialize a Global optimization process at t + 1. The heuristic used can be the same as in the static case or a different one. A typical example of a method in this category (Aynaud and Guillaume, 2010) consists in using the Louvain algorithm: in its original definition, at initialization, each node is in its community. The partition update version of it consists in initializing Louvain with communities found in the previous step. Methods in this subcategory: (Alvari et al., 2014; Ay- naud and Guillaume, 2010; Bansal et al., 2011; Gorke et al., 2010; Miller and Eliassi-Rad, 2009; Shang et al., 2014) Refer to Appendix IX.A for methods description. 2. Update by Set of Rules Methods in this subcategory consider the list of net- work changes (edge/node apparitions, vanishing) that oc- curred between the previous step and the current one, and define a list of rules that determine how networks changes lead to communities update. Methods that fol- low such rationale can vary significantly from one to the other. When addressing community detection on Snapshot Graphs, two different aspects need to be evaluated for each snapshot: partition quality and temporal partition coherence. The multi-objective optimization subclass groups together algorithms that try to balance both of them at the same time so that a partition identified at time t represents the natural evolution of the one iden- tified at time t − 1. This approach optimizes a quality function of the form: c = αCS + (1 − α)CT (1) with CS the cost associated with current snapshot (i.e. how well the community structure fits the graph at time t), and CT the smoothness w.r.t. the past history (i.e., how different is the actual community structure w.r.t. the one at time t− 1) and α ∈ [0, 1] is a correction factor. An instantiation of such optimization schema could be defined using modularity (Newman and Girvan, 2004) as CS and Normalized Mutual Information (Lancichinetti et al., 2008) as CT as done in (Folino and Pizzuti, 2010). Methods in this subcategory: (Crane and Dempsey, 2015; Folino and Pizzuti, 2010; Gong et al., 2012; Gorke et al., 2013; Kawadia and Sreenivasan, 2012; Lin et al., 2008, 2009; Sun et al., 2010; Tang et al., 2008; Yang et al., 2009; Zhou et al., 2007) Refer to Appendix IX.C for methods description. G t1P1 t1C1 t1C2... t1C3InitialisationG t2P2P1C1P1C2...P1Cn t2C1 t2C2... t2Cn...ResultCommunitiesupdatesG tnP2P1C1P1C2...P1Cn tnC1 tnC2... tnC3CommunitiesupdatesDC1 t1C1 t1C2... tnCnDCn t1C2 t2C1... tnCn... 14 In theory, these methods have more potential to deal with local anomalies and slow evolution running through multiple steps, that iterative processes might not be able to perceive, due to their narrower focus. Drawbacks Cross-Time approaches, unlike previ- ous ones, are not based on the usual principle of a unique partition being associated with each step of the graph evolution process. It, therefore, requires to develop novel techniques and to make new assumptions on the nature of dynamic communities. As a result, most methods suffer from constraints such as fix number of communities and absence of operations such as merge or split. Another drawback is that such approaches are not able to handle on-the-fly/real-time community detec- tion. Indeed, since their computation needs a complete knowledge of all the network history, in the presence of a new evolutive step the partition extraction needs to be performed from scratch. Network Models Both Network Snapshots and Temporal Networks can be used by Cross-Time ap- proaches. Subcategories: All algorithms in the Cross-Time class do not have the same constraints on the nature of searched communities. We can classify them in four cat- egories: (i) Fixed Memberships, fixed properties (ii) Fixed memberships, evolving properties (iii) Evolving member- ships, fixed properties (iiii) Evolving memberships, Evolv- ing properties. 1. Fixed Memberships, fixed properties Methods in this subcategory do not allow nodes to switch communities, nor communities to appear or disap- pear. They also assume that communities stay the same throughout the studied period. As a consequence, they search for the best partition, on average, over a time pe- riod. In most cases, they improve the solution by slicing the evolution in several time periods, each of them con- sidered homogeneous, and separated by dramatic changes in the structure of the network, a problem related to change point detection (Peel and Clauset, 2015). Methods in this subcategory: (Aynaud and Guillaume, 2011; Duan et al., 2009; Sun et al., 2007) Refer to Appendix X.A for methods description. 2. Fixed memberships, evolving properties Methods in this subcategory are aware that communi- ties are not homogeneous along time. For instance, nodes in a community can interact more actively during some recurrent time-periods (hours, days, weeks, etc.), or their FIG. 7 Cross Time. Communities are extracted by leverag- ing, all at once, the information gathered by the complete temporally annotated history of the analyzed network. Leg- end: G: Graph, P: Partition, DC: Dynamic Community, C: Community 4. Informed CD by network smoothing Methods in this subcategory search for communities at t by running a CD algorithm, not on the graph as it is at t, but on a version of it that is smoothed accord- ing to the past evolution of the network, for instance by adding weights to keep track of edges' age. In a later step, communities are usually matched between snapshots, as in typical Two-Stage approaches. Contrary to previous subcategories, it is not the previous communities that are used to take the past into account, but the previous state of the network. Methods in this subcategory: (Guo et al., 2014; Kim and Han, 2009; Xu et al., 2013a) Refer to Appendix IX.D for methods description. C. Cross-Time Communities Discovery Approaches belonging to the Cross-Time class do not consider independently the different steps of the network evolution. On the contrary, DCD is done in a single pro- cess, considering -- at the same time -- all states of the net- work. A visual representation of this class of approaches is shown in Figure 7. An example of algorithmic procedures that fall in this class is the following: 1. Network Transformation: from a sequence of snap- shots, a single network is created in which each meta-node corresponds to the presence of a node at a given snapshot. Two kinds of edges are de- fined on this network: (i) the usual relationship between nodes at the same time-step, and (ii) addi- tional edges that link nodes belonging to different, adjacent, time-steps. 2. Community Detection: A static community detec- tion algorithm is run on this transversal network: identified communities contain nodes belonging to different time steps, interpretable as dynamic com- munities. Advantages This class of algorithms does not suffer from problems of instability and community drift that affect previous ones. G t1G t2...G tnResultDC1 t1C1 t1C2... tnCnDCn t1C2 t2C1... tnCn...Cross TimeExtraction activity might increase or decrease along time. To each community -- whose membership cannot change -- they assign a temporal profile corresponding to the evolution of its activity. Methods in this subcategory: (Gauvin et al., 2014; Ma- tias et al., 2018) Refer to Appendix X.B for methods description. 3. Evolving memberships, fixed properties Methods in this subcategory allow node memberships to change along time, i.e., nodes can switch between com- munities. However, because they use Stochastic Block Models approaches, for which the co-evolution of mem- berships and properties of communities is not possible (see (Matias and Miele, 2016)), the number of commu- nities and their density is fixed for the whole period of analysis. Methods in this subcategory: (Ghasemian et al., 2016; Herlau et al., 2013; Ishiguro et al., 2010; Matias and Miele, 2016; Yang et al., 2009, 2011) Refer to Appendix X.C for methods description. 4. Evolving memberships, evolving properties Methods in this category do not impose constraints on how dynamic communities can evolve: nodes can switch between them, communities can appear or disappear, and their density can change. Three main approaches are currently present in this category: • In (Jdidia et al., 2007) and (Mucha et al., 2010), edges are added between nodes in different snap- shots. Static community detection algorithms are consequently run on this trans-temporal network • In (Viard et al., 2016) and (Himmel et al., 2016), the authors search for persistent cliques of a mini- mal size in link streams • In (Xu and Hero, 2014), a dynamic stochastic block model is defined that allows both affiliations and densities to change. Methods in this subcategory: (Himmel et al., 2016; Jdidia et al., 2007; Mucha et al., 2010; Viard et al., 2016; Xu and Hero, 2014) Refer to Appendix X.D for methods description. D. Discussion As we have seen in this section, all three classes of approaches have advantages and drawbacks; none is su- perior to the other. Nevertheless, we have observed how each one of them is more suitable for some use cases. For instance, if the final goal is to provide on-the-fly community detection on a network that will evolve in 15 the future, approaches that fall in the first two classes represent the most suitable fit. If the analytical con- text requires working with a fine temporal granularity, therefore modeling the observed phenomena with tem- poral networks, it is strongly suggested to avoid methods of the first class, that can only deal with snapshots. The first layer of our taxonomy can thus be used to pro- vide guidance and recommendations on which approach (or class of approaches) select given a specific problem formulation. For instance, we can observe how, • Instant Optimal approaches are the best choice when the final goal is to provide communities which are as good as possible at each step of the evolution of the network. • Cross-Time approaches are the best choice when the final goal is to provide communities that are coherent in time, in particular over the long-term. • Temporal Trade-off approaches represent a tradeoff between these other two classes: they are the best choice in case of continuous monitoring, rapidly evolving data, and in some cases limited memory applications. The second layer of classification groups together ap- proaches that share the same rationale. This further clas- sification is useful, in our opinion, to those researchers that need to frame their method within a specific litera- ture. Identifying the particular family a DCD approach belongs to is valuable to understand which are its real competitors and, doing so, to better organize compara- tive analysis, reducing the bias introduced by the slightly different problems addressed (as well as community def- initions adopted) by alternative methods. V. EVALUATION So far we introduced our taxonomy and framed the DCD algorithms we identified within it. In this section, we will address a very sensitive theme related to any data mining task: evaluation. Indeed, finding a reliable way to evaluate partition quality is a significant issue to address while approaching community discovery. One of the main issues of the community discovery lies in the absence of a unique definition of community: each scholar follows its strategy to compare the results obtained by its algorithm with those produced by other state-of-the-art methods, each one defining specific characteristics that a proper network partition should express. Often, the comparison is made amongst methods hav- ing similar characteristics: algorithms that optimize the same quality function (i.e., modularity, conductance, density. . . ), that produce overlapping/crisp/hierarchical network partitions, which are designed to work on di- rected/undirected graphs,. . . . To shed some lights on the most popular evaluation strategies adopted in liter- ature, in the following we categorize them and discuss testing environments used to evaluate community parti- tions. In particular, in Section V.A, we describe how synthetic network generators are often used to design controlled experiments: there we introduce two classes of benchmarks built upon them, namely static and dy- namic ones. Finally, in Section V.B we discuss two fam- ilies of approaches designed to assess community quality, namely internal and external evaluation. A. Synthetic Network Generators Several network properties can be used to characterize real-world phenomena: network modeling aims to repli- cate them thus allowing for the generation of synthetic datasets that, at least to some extent, can be used as analytical proxies. The general aim of network modeling is to capture some essential properties lying behind real- world phenomena and replicate them while generating synthetic data, imposing only a few simple constraints. Several models of increasing complexity and realism were proposed during the 20th century, the most famous being Erdos and R´enyi random graphs (R´enyi and Erdos, 1959), Watts and Strogatz small-world networks (Watts and Strogatz, 1998), Barab´asi and Albert Preferencial at- tachment model (Barab´asi and Albert, 1999), Leskovec's Forest Fire (Leskovec et al., 2005) and Community- Affiliation Graph (Yang and Leskovec, 2014). For a more detailed presentation of the history of network models, refer to (Rossetti, 2015) Complex network modeling studies generated a new synthetic network generators. Gen- field of research: erators allow scientists to evaluate their algorithms on synthetic data whose characteristics resemble the ones that can be observed in real-world networks. The main reason behind the adoption of network generators while analyzing the performances of a community discovery al- gorithms is the ability to produce benchmark datasets that enable for: • Controlled Environment testing: Network genera- tors allow to fine-tune network characteristics -- i.e., network size and density. Such flexibility enables an extensive algorithm evaluation on networks hav- ing different characteristics but generated to follow similar topologies. Generators make possible, given a CD algorithm, to evaluate: -- Stability: the performance of a CD approach can be evaluated on a high number of network instances having similar properties to provide an estimate of the algorithmic stability; -- Scalability: synthetic graphs can be used to test the actual scalability of an algorithm while increasing the network size. • Ground-truth testing: some network generators provide as a by-product a ground-truth partition 16 of the generated network. Such partition can be used to evaluate the one provided by the tested al- gorithm. Two families of network generators have been described to provide benchmarks for community discovery algo- rithms: generators that produce static graphs-partitions and generators that describes dynamic graphs-partitions. Surprisingly, the formers are often used to evaluate also DCD algorithms: this happens because they are more widespread than the latter, and allows comparison with static algorithms. Of course, they can only be used to evaluate the quality of the detection at time t, and not the smoothness of communities. Static Benchmarks. The classic and most famous static benchmarks are the Girvan-Newman (introduced by Girvan and Newman (Girvan and Newman, 2002)) and the LFR (introduced by Lancichinetti et al. (Lanci- chinetti et al., 2008)). The Girvan-Newman benchmark, also known as GN, is built upon the so-called planted l-partition model described in (Brandes et al., 2003; Condon and Karp, 2001; Gaertler et al., 2007) this generator takes as input a given ground truth partition (generated as as equally sized Erdos-Re´nyi random graphs (R´enyi and Erdos, 1959)) and two parameters identifying respectively the probabilities of intra and inter-clusters links. Planted l-partition models (also known as ad-hoc models) where proposed to produce graph having different characteristics: overlapping community structures (Danon et al., 2006; Sawardecker et al., 2009) as well as weighted (Fan et al., 2007) and bipartite (Guimer`a et al., 2007) graphs were modeled in order to better mimic real network characteristics. To cope with the limitation of the GN benchmark (Poisson degree distribution, equal community sizes), and to fill the gap among Erdos-R´enyi graphs and real ones, in (Lancichinetti et al., 2008) was introduced . The networks generated by this model have both node degrees and community sizes following a power law distribution. LFR has also been generalized to handle weighted and directed graphs, as well as to generate overlapping communities (Lancichinetti and Fortunato, 2009). Dynamic Benchmarks. Recently a few papers have proposed extensions of GN and LFR that introduce topology dynamics as well as entirely new dynamic benchmarks. In (Lin et al., 2008), a variant of the GN model is in- troduced to evaluate the FaceNet framework. There, the authors introduce network dynamics by generating differ- ent graph snapshots and interpolating from a snapshot to its subsequent by (i) randomly selecting a fixed number of nodes from each community (ii) removing them and (iii) allocating them to different communities. In (Greene et al., 2010), a dynamic benchmark built upon LFR is introduced: starting from a static synthetic graph with ground-truth communities such benchmark randomly permuted 20% of the node memberships to mimic node-community migrations. In (Granell et al., 2015), a new model based on Stochastic Block Models is proposed: a graph is split into q subgraphs where nodes belonging to the same sub- graph are connected with probability pin, while edges connecting subgraphs have probability pout then ad-hoc procedure make the network evolve generating commu- nity events. In (Bazzi et al., 2016), a generic approach is proposed to generate both multilayer and temporal net- works with a community structure. The method adopts a 2 steps process: 1) Generating a multi-layer partition sat- isfying user-defined parameters 2) Sampling edges consis- tent with the partition. The underlying model of edges and partition is the degree-corrected SBM. An interlayer dependency tensor allows to define how strongly the com- munity structure in one layer depends on other layers. In the case of dynamic networks, the layer corresponding to time t typically depends only on the network at time t − 1. The model does not support community events, but provide an implementation in MATLAB1. Finally, in (Rossetti, 2017) RDyn, a new benchmark specifically tailored for the DCD problem, is introduced. RDyn2 generates dynamic network topologies (both in SN and TN format) as well as temporally evolving ground-truth communities. B. Methodologies Community partitions can be evaluated pursuing external as well as internal quality analysis strategies. The former methodologies assume the existence of an external ground truth that needs to be retrieved or a specific partition quality score to optimize. The latter instead focus on the inspection and description of topologies identified as well as on the evaluation of the approach's complexity and scalability. External: ground-truth communities. We have seen how Girvan-Newman and LFR were designed to produce tunable network structures having ground-truth partitions. Moreover, several real-world datasets also come with associated community annotations3. Ground-truth community structures have well-known characteristics (i.e., fixed size, density, cut-ratio. . . ) and/or semantic coherence (i.e., node label homophily on a given external attribute). For these reasons, a way to evaluate the effectiveness of community discovery al- gorithms consists in comparing the divergence between 1 https://github.com/MultilayerBenchmark/ MultilayerBenchmark/ 2 RDyn code available at: https://goo.gl/WtLg4V 3 See: https://snap.stanford.edu/data/index.html# communities 17 the partition they produce and the planted one. Al- though several criticisms were opposed to this evaluation methodology (Peel et al., 2017) (e.g., since the commu- nity discovery is an ill-posed problem it is not assured that the planted partition is the optimal one for all qual- ity functions optimized by existing algorithms), it is still the most widely spread to compare different algorithmic approaches. The common way to assess how a given partition resembles the ground-truth one is to compute the Normalized Mutual Information score (NMI, (Lanci- chinetti et al., 2009, 2008; McDaid et al., 2011)) a mea- sure of similarity borrowed from information theory, de- fined as (Rossetti et al., 2016): N M I(X, Y ) = H(X) + H(Y ) − H(X, Y ) (H(X) + H(Y ))/2 (2) where H(X) is the entropy of the random variable X associated to an identified community, H(Y ) is the en- tropy of the random variable Y associated to a ground truth one, and H(X, Y ) is the joint entropy. NMI is de- fined in the interval [0,1] and is maximal when the com- pared communities are identical. One drawback of NMI is that assuming an approximate size z for the compared community sets its computation requires O(z2) compar- isons, a complexity that makes it often unusable to eval- uate partitions of large-scale networks. To cope with the high computational complexity of such method in recent years, several approaches were proposed (Cazabet et al., 2015; Rossetti et al., 2017, 2016). As an example, in (Rossetti et al., 2017, 2016) the F1-community score has been introduced. In such work the evaluation problem is solved as a classification task: • network nodes are labeled according to their ground-truth community label; • each community identified by the tested algorithm is matched to the ground-truth one whose label is shared by the majority of its nodes; • precision and recall are computed for each commu- nity by considering the actual nodes and the real ones; • the F1-community score is computed as the average of the harmonic mean of precision and recall of the matched communities. This approach (used in (Rossetti, 2017; Rossetti et al., 2017) where a normalized version, NF14, is proposed to cope with community overlap and redundancy) re- quires O(z) to be computed (assuming an already la- beled graph). Moreover, it allows to graphically visualize the performances of a given algorithm via density scatter 4 NF1 code available at: http://goo.gl/kWIH2I 18 In (Fortunato and Barth´elemy, 2007), the authors prove that partitions of optimal modularity do not necessar- ily correspond to what one expect as good communities, in particular, they introduced the problem of "resolution limit," that may prevent from detecting small communi- ties in large networks, and vice-versa. Indeed, modularity is not the only measure used to evaluate partition quality. Among the most used we can recall: • Conductance (Radicchi et al., 2004; Yang and Leskovec, 2015), i.e., the percentage of edges that cross the cluster border; • Expansion (Radicchi et al., 2004), i.e., the number of edges that cross the community border; • Internal Density (Radicchi et al., 2004), i.e., the ratio of edges within the cluster w.r.t. all possible edges; • Cut Ratio and Normalized Cut (Fortunato, 2010; Shi and Malik, 2000), i.e., the fraction of all possible edges leaving the cluster; • Maximum/Average ODF (Flake et al., 2000) (out- degree fraction), i.e. the maximum/average frac- tion of nodes' edges crossing the cluster border; • Flake ODF (Flake et al., 2000), i.e., the fraction of nodes involved in fewer edges within the community than outside it; • Volume, i.e., the sum of degrees of nodes in the community; • Edge Cut, i.e., the number of edges that should be removed to destroy all the paths connecting the community to the rest of the network. All these indicators are used to get insights on the compactness and topological consistency of communi- ties. Studies about the relations between these quality functions can be found in (Creusefond et al., 2016; Yang and Leskovec, 2015). However, evaluating solutions based on a golden quality function has a major draw- back: it favors methods that are designed to maximize it. Even though such strategy can be used fruitfully to compare methods that explicitly optimize a specific measure, its application to approaches that search for communities having different definition may pro- duce misleading, or inconclusive/irrelevant, comparisons. Internal. Several works overcome the issue of identi- fying a qualitative ranking among different algorithms by proposing a quantitative evaluation: instead of com- paring with a ground-truth or computing quality mea- sures, they focus on the algorithmic complexity (Bourqui et al., 2009; Rossetti et al., 2017; Tantipathananandh et al., 2007), running time (Gupta et al., 2012; Li et al., 2011; Rossetti et al., 2017; Shao et al., 2014), scalability FIG. 8 F1-community measure scatter plot. Each point represent the (precision,recall) pairs for a given match: the deeper the color the more the communities sharing the same values of (precision,recall) values. The optimal matching value is the upper right corner (precision and recall equals to 1): communities having high precision and low recall (bottom- rigth corner) underestimate the ground-truth ones, commu- nities having low precision and high recall (top-left corner) overestimate the ground truth ones. plots. As an example, Figure 8 shows a visual representa- tion of F1-community where the communities identified by a CD method are compared with ground-truth ones. Although real datasets with ground-truth communities as well as the LFR/GN benchmarks are commonly used to perform testing of DCD approaches by considering the network at a particular instant of its evolution, it is mandatory to underline one huge deficiency: such meth- ods do not take into account the temporal dimension. In particular, GN and LFR were designed to allow ground- truth testing for classical static community discovery algorithms. For this reason, their use in conjunction with dynamic approaches raise several practical issues: how to generate subsequent (coherent) network snapshots? Is it possible to revise them to produce interaction networks? If so how can they reliably mimic edge/node vanishing? One of the open problems that afflict DCD is, as of today, the evaluation of the produced communities: how can time-aware ground-truths partitions be defined (even in synthetic scenarios)? As discussed in Section V.A, so far only a few approaches have been designed to address these latter issues (e.g., RDyn (Rossetti, 2017)). External: quality function. In absence of ground- truth communities, a common way to compare different algorithms is to rank their partitions w.r.t. a community quality score. The algorithm that produces the parti- tion reaching the highest score is then, by definition, considered the best one for the analyzed network. Modularity (Newman, 2004; Newman and Girvan, 2004) is probably the most widely used quality function. Values of Q approaching 1 indicate partitions with strong community structure, while values close to 0 indicates that the partition does not correspond to a community structure. Modularity has been extensively used both to evaluate and define community discovery algorithms for static and dynamic networks. However, the legiti- macy of modularity has been challenged in recent years. (Folino and Pizzuti, 2014; Tan et al., 2014; Zakrzewska and Bader, 2015) or analysis enabled by their approaches (i.e., identification of specific life-cycle events (Cazabet et al., 2012; Lee et al., 2014; Palla et al., 2007)). Internal evaluations, conversely from external ones, do not want to produce a direct comparison among differ- ent partitions: they assume that each algorithm is based on a different community definition and -- after having described the structures each approach generates -- they measure quantitative performances and define a context of applicability for the proposed algorithm. Indeed, in- ternal evaluation techniques are often used as support for external one, as in (Agarwal et al., 2012; Folino and Piz- zuti, 2014; Rossetti et al., 2017). The need for an evalua- tion strategy alternative to the external ones is primarily due to the intrinsic ill-posedness of the treated problem. As we discussed, community discovery in dynamic net- works can be declined in several ways, by imposing differ- ent constraints on the network representation and its dy- namics as well as focusing the analytical goal on different objectives. This heterogeneous and fascinating scenario makes the evaluation task complex: unfortunately, so far complete and accepted methodologies able to address it were not presented, thus leaving researchers without a golden standard to follow. VI. APPLICATIONS Once categorized existing DCD approaches as well as the strategies adopted to validate their results, in this Section, we briefly discuss some related themes. In Sec- tion VI.A, the main categories of real-world dynamic net- work datasets are described, while in Section VI.B visu- alization strategies for dynamic networks are introduced. Finally, in Section VI.C examples of how DCD can be used as an analytical tool are provided. A. Real World Dynamic Networks The proliferation of online services, as well as the continuous collection of data regarding human activities, have given birth in recent years to the so-called Big Data science. Indeed, almost all kinds of human-generated content can be used to model graphs: online social networks, mobility traces, information regarding collab- orations or trade exchanges, web traffic are all examples of contexts in which it is possible to define relations among objects and design networks to analyze them. Unfortunately, so far only a few easily accessible online resources were made available to researchers to test dynamic network analytical tools. This situation is mostly due to the novelty of this research field: while static network datasets of any size (often enriched by valuable semantic annotations) have always been objects of analysis -- and thus collected and cataloged -- dynamic ones are often small, not well organized and 19 Dataset Url DBLP http://goo.gl/5R9ozh cond-mat http://arxiv.org cit-HepTh/Ph http://arxiv.org IMDB http://imdb.com Papers (Goldberg et al., 2011; Ma and Huang, 2013; Miller and Eliassi-Rad, 2009; Takaffoli et al., 2011; Tang et al., 2008; Wang et al., 2008) (Wang et al., 2008) (Gorke et al., 2013; 2015; Shang et al., 2014) (Goldberg et al., 2011) Ilhan and Oguducu, TABLE I Dynamic Collaboration Networks rare. Nevertheless, DCD approaches are often tested on such kind of datasets to evaluate their performances and compare runtimes on real-world scenarios. In the following we discuss the main online and offline sources used to extract dynamic networks and provide a catalog of currently available datasets. Collaboration Networks. An extensively stud- ied type of dynamic networks is the one that models work related collaborations, such as co-authoring of scientific publications or movie creation. Collaboration networks are extensively used by methods that work on snapshot graphs due to the natural timescale they provide (usually scientific papers -- as well as movies -- can be referred by their publication year). One drawback of networks built upon such kind of data is their lack of adherence to classical canons of real social networks: they are composed of interactions between groups more than activities between pairs of entities. Such characteristic reflects into networks structures composed of clique-chains whose density is usually higher than what is expected in traditional social networks. In Table I are reported the most used online resources. Online/Offline Social Networks. The second class of sources often used to generate dynamic graphs is pro- vided by online/offline social contexts. This kind of data is characterized by a clear semantic link: self-declared social relationships (that can be considered systemat- ically reciprocated -- thus giving birth to undirected graphs -- or not necessarily so -- thus giving birth to directed graphs). Social structures are often analyzed in different snapshots, whose durations are defined by the analyst since there is no natural temporal resolution to apply (as we have already discussed in Section II and in Section II.B). They can also be studied as temporal networks of relations. In Table II are listed some online datasources used to test algorithms discussed in Section IV. Communication Networks. Data regarding commu- Papers Dataset (Lee et al., 2014) Twitter Delicious.com http://delicious.com (Sun et al., 2010) Url http://twitter.com TABLE II Online/Offline Social Networks Dataset Url ENRON https://goo.gl/gQqo8l Papers (Falkowski et al., 2008; Ferry and Bumgar- ner, 2012; Folino and Pizzuti, 2010, 2014; Li et al., 2011; Shang et al., 2014; Tang et al., 2008; Wang et al., 2008) KIT https://goo.gl/gQqo8l (Gorke et al., 2013) Mobile phone - (Folino and Pizzuti, 2010, 2014; Gong et al., 2012; Guo et al., 2014) 20 https://goo.gl/pzhst2 (Shang et al., 2014) wiki-Vote Senate/Court Voting - Thiers CAIDA Facebook Weibo Digg Slashdot http://goo.gl/jhAcY8 http://goo.gl/72y9iT http://goo.gl/8J18cw http://goo.gl/bcoQiy http://goo.gl/ybKQS2 http://goo.gl/FGgEiM (Crane and Dempsey, 2015) (Viard et al., 2016) (Miller and Eliassi-Rad, 2009) (Rossetti et al., 2017) (Rossetti et al., 2017) (Zakrzewska and Bader, 2015) (Zakrzewska and Bader, 2015) FIG. 9 Visusalisation using contour map on top of nodes po- sitioned with an appropriate layout. Image taken from: (Lin et al., 2010) (Copyright 2010 Society for Industrial and Ap- plied Mathematics. Reprinted with permission. All rights reserved.) TABLE III Examples of real world dynamic graphs: Com- munication Networks nications (i.e., phone call logs, chats/emails, face-to-face are often released with very precise interactions. . . ) timestamp annotations. Such fine-grained temporal information makes possible to build upon them not only snapshot graphs but also temporal networks of inter- actions, or of relations using a chosen TTL (Time To Live). Those datasets, listed in Table III, are primarily used by Partition update by set of rules approaches (see Section IV.B). Technological Networks. The last class of networks widely adopted to test dynamic algorithms is the tech- nological one. Peer-to-Peer networks, as well as graphs built on top of Autonomous Systems routing information, are classical datasets, often used to validate even static community discovery approaches. In Table IV are shown some examples of technological networks used in revised algorithms. B. Visualization Dynamic network visualization is a challenging task: so far, to the best of our knowledge, few solutions have been proposed to visualize the evolution of communities. Ef- fectively represent community dynamics is difficult since it needs to combine the challenges presented by both evolving network and communities visualization. For a survey on the visualization of dynamic networks, please refer to (Beck et al., 2017). For a survey on the visual- ization of community structures, please refer to (Vehlow et al., 2015b). We can classify visualization methods in two cat- egories: (i) dynamic visualizations, such as videos, in which the state of communities at different time steps is represented by independent visualizations and Dataset Url AS Routers https://goo.gl/tGk1lJ Papers (Alvari et al., 2014; Gorke et al., 2013) p2p-Gnutella https://goo.gl/Tgl5NC (Ma and Huang, 2013) TABLE IV Technological Networks (ii) static drawings that summarize the whole net- work/communities evolution. 1. Dynamic Visualization Methods falling in this category have been designed to represent communities in static networks, and have been extended to handle dynamic networks by the means of animations. This adaptation usually consists in using a layout of nodes adapted to favor the stability of their position despite the changes in their connectivity. (Frishman and Tal, 2004) focus on minimizing the change of positions of each cluster as a whole, and of the nodes within them. Invisible nodes representing com- munities are used to ensure the stability of community centroids. Communities are represented by node color- ing, and/or by drawing a square around nodes belonging to the same group. In (Beir´o et al., 2010), the whole community is rep- resented as a single node, whose size corresponds to its number of components. Edges between communities rep- resent all the links that connect their respective nodes. In (Boyack et al., 2008), communities are shown as pie- charts, a visualization used to summarize some property of the nodes they are composed of. (Hu et al., 2012) proposes to position nodes in the net- work based on a classic node positioning layout, and then overlay a shape on top of the nodes belonging to the same community, in a manner appropriate for an easy under- standing of the community structure, inspired by geo- graphical maps. In (Lin et al., 2010) a similar approach is used, but a fuzzy contour-map is used to represent communities. (Fig. 9) 2. Static Visualization In (Mucha et al., 2010), a vertical position is attributed to each node, according to its first apparition and its community affiliation, in order to put similar nodes close to each other. The horizontal axis corresponds to time. A color is attributed to each community, and, for each timestamp, the node, if present, is represented by a dot colored according to the community it belongs to (see Fig. 10). In (Reda et al., 2011), each community is represented as a fixed-width horizontal space and nodes as colored lines that switch between them when community affilia- tion changes occur. A similar idea is proposed in (Rosvall and Bergstrom, 2010). There, alluvial diagrams are used to represent community evolution: each node is represented as a con- tinuous line, whose vertical position is determined by its community affiliation. Nodes belonging to the same com- munity at a given timestamp always appear next to each other and sharing the same color. Therefore, communi- ties appear as horizontal strips whose width corresponds to the number of nodes they contain. The authors of (Vehlow et al., 2015a) propose to com- bine views of the structure of the communities with the alluvial representation. They employ a custom sorting of the communities and vertices per time step to minimize crossing, and an automatic color assignment methods to improve readability (see Fig. 11). The authors of (Morini et al., 2015) use a variation of the alluvial diagram in which the vertical position of communities is less constrained, facilitating the tracking of communities life-cycles.( see Fig. 12) In (Vehlow et al., 2016), a method is proposed to visu- alize both a hierarchical organization of communities and their evolution through time. The method use matrices to represent each step, and the relations between com- munities in different time steps or different hierarchical levels are represented by edges between the communities. C. DCD as a tool Several articles (Agarwal et al., 2012; Cazabet et al., 2012; Lee et al., 2014) proposed to use DCD algorithms to identify events in online social networks. The gen- eral approach they follow consist of creating a dynamic FIG. 10 Visusalisation used by Mucha et al. from: (Mucha et al., 2010) Image taken 21 FIG. 11 Visusalisation by alluvial diagrams. from: (Vehlow et al., 2015a) Image taken FIG. 12 Variation of the alluvial diagram to improve the read- ability of the life-cycle of communities. Image taken from: (Morini et al., 2015) network of keywords or n-grams, in which edges corre- spond to a semantic relationship between terms observed in the studied OSN. The dynamic communities found on such networks correspond to "popular events" aggregat- ing similar bursting terms. The evolution of groups of people in social media has also been addressed in (Gliwa et al., 2012; Saganowski et al., 2015), on a Polish blogo- sphere service, Facebook, and DBLP. DCD approaches could also be used as a tool for telecommunication networks. As such methods allow to keep up-to-date information on the community structure in real-time, they enable for the adoption of algorithms able to extract knowledge from highly dynamical network substructures. In (Nguyen et al., 2011b), the authors pro- pose to use DCD for improving routing in MANETs (Mo- bile Ad Hoc Networks), while in (Nguyen et al., 2011a), the authors propose to use them to contain worms, no- tably by concentrating on the immunization of nodes at the interface between the infected community and the Figure 2: Overview of the alluvial diagram. Nodes are labelled according to the most frequent (top) author in each cluster. ​Zoomable version available at http://perso.ens-lyon.fr/matteo.morini/wavelets/sankeyzoom/sankey_s.pdf Figure 4: Clusters condensing around the inception of "wavelets" (photo1/zoom #1) 4 rest of the network. In (Schlitter and Falkowski, 2009), the authors study the music listened by a set of 1800 users on the platform Last.fm over a period of 3 years. They detect groups of users capturing specific music gen- res and study their evolution. For instance, they observe the fusion between a group of users listening to progres- sive metal and another group listening to death metal. Scientific collaboration network analysis is a topic on which DCD algorithms have been applied several times, notably in (Cazabet et al., 2010; Lin et al., 2009; Rosvall and Bergstrom, 2010; Van Nguyen et al., 2012). One of the most in-depth analysis can be found in (Rosvall and Bergstrom, 2010), where a merge between the fields of Neurology, Psychology and some areas of Molecular and Cell biology is identified, forming a new field of Neuro- science between 2003 and 2005. In (Braun et al., 2015), DCD is used to study the re- configuration of the brain network during executive cog- nition in humans. Finally, in (Mucha et al., 2010), political affiliation among senators is studied based on vote similarities. Known historical changes in U.S politics are compared with communities of senators found by a dynamic com- munity discovery algorithm. The same method has been applied for the United Nations General Assembly (Macon et al., 2012), exploring different processes to construct the network from data. VII. OUTLOOK Despite the significant amount of literature already published on the topic of Dynamic Community Discovery, numerous lines of research remain open. The problem per se is not trivial: indeed, we have seen that it cannot be reduced to simply running a static algorithm at several points in time. As the scientific community is still tackling the prob- lem of what is a good community, researchers on DCD are confronted with the problem of defining what it means for a community to persist and evolve. Moreover, they need to solve the apparent paradox that "optimal" par- titions found during different network evolution steps do not always form a coherent dynamic structure. An underlying problem is due to the heterogeneous na- ture of the dynamic networks used by different methods. While snapshots and temporal networks have the same expressivity -- i.e., both of them can be used to model the same network topology dynamics -- they often have to be considered differently in practice. Snapshots are often used when the network varies greatly between sub- sequent observations, while temporal networks represent a fine-grained evolution. As a consequence, a method de- signed for one of these approaches often solve a different problem than one designed for the other. The classification we have adopted highlights the amazing variety of approaches adopted by different au- thors. Such DCD methodologies do not only propose dif- 22 ferent ways of solving the same problem, but also explore different definitions of what is a dynamic community, and how to find network partitions which are both coherent on the long run and meaningful at given points in time. Despite this variety of definitions and approaches, com- mon grounds have begun to emerge, in particular, the definition of events or operations. What we think the field lacks the most is a common ground to evaluate and compare the different methods among themselves. Indeed, earliest methods for Commu- nity Detection have compared themselves to the Zachary Karate Club, while there is no such widespread toy model for dynamic networks. More importantly, the field of CD has been structured by the introduction of advanced benchmark and system- atic, quantitative comparison of algorithms. While a few steps have been done in this direction, by introducing simplistic synthetic benchmarks, there is still no univer- sally recognized benchmark equivalent to the LFR for the dynamic case, and no systematic comparison of methods has been conducted yet. The problem is indeed arduous: to compare methods and their results, it is mandatory to provide to each method an appropriate input, and convert outputs to comparable pieces of information. In- deed, the problem is not only a technical one: it involves the lack of standard formal definitions. How to com- pare methods working on a few snapshots and methods on temporal networks? How to compare results that do not share the same possible operations of communities? And how to design a benchmark that generates realistic evolution of communities while such evolution is not well known yet? A question many will ask is: what method should I use for my data? Unfortunately, there is not a final answer to this question, in particular, due to the lack of systematic evaluation. Nevertheless, the classification of methods according to their characteristics already give us some hints. A first aspect to consider is the number of steps of evolution present in the original data. If there are few steps, (i.e. less than 10), typically corresponding to ag- gregated observations over months or years, one should in priority consider approaches based on snapshots, while if the number of steps is high (1000s or more), methods using temporal networks are more suitable. Another as- pect is the priority given to the quality of communities found at a particular instant rather than to the coherence of the continuity of communities. For instance, a tool us- ing DCD to improve in real-time the routing in a point to point network might give a higher importance to the current state of the network. Conversely, a retrospective analysis of past events aimed at interpreting the emer- gence of scientific fields by clustering journals or papers should favors the long-term coherence of communities. Finally, we observed that despite a large number of methods proposed, few applications of DCD to concrete problems were proposed -- except the ones by the authors themselves. As of today, it seems that the field lacks a visibility and that authors who need a DCD method tend to develop their own, ad-hoc algorithm, often without considering existing ones. We think that the future of the field will rely on its greater cohesion and ease of access for newcomers, to reach an audience as large as conventional Community Discovery. Acknowledgement We thank Jane Carlen for her feedback that helped us correct some errors in the description of some methods. References Agarwal, M. K., Ramamritham, K., and Bhide, M. (2012). Real time discovery of dense clusters in highly dynamic identifying real world events in highly dynamic graphs: environments. the VLDB Endowment, 5(10):980 -- 991. Proceedings of Alon, U. (2007). Network motifs: theory and experimental approaches. Nature Reviews Genetics, 8(6):450 -- 461. Alvari, H., Hajibagheri, A., and Sukthankar, G. (2014). Com- munity detection in dynamic social networks: A game- theoretic approach. In IEEE/ACM International Confer- ence on Advances in Social Networks Analysis and Mining (ASONAM), pages 101 -- 107. IEEE. Asur, S., Parthasarathy, S., and Ucar, D. (2009). An event- based framework for characterizing the evolutionary behav- ior of interaction graphs. Transactions on Knowledge Dis- covery from Data (TKDD), 3(4):16. Aynaud, T., Fleury, E., Guillaume, J.-L., and Wang, Q. (2013). Communities in evolving networks: definitions, de- tection, and analysis techniques. In Dynamics On and Of Complex Networks, Volume 2, pages 159 -- 200. Springer. Aynaud, T. and Guillaume, J.-L. (2010). Static community detection algorithms for evolving networks. In Proceedings of the 8th international symposium on Modeling and opti- mization in mobile, ad hoc and wireless networks (WiOpt), pages 513 -- 519. IEEE. Aynaud, T. and Guillaume, J.-L. (2011). Multi-step commu- nity detection and hierarchical time segmentation in evolv- ing networks. In Proceedings of the 5th Social Network Min- ing and Analysis Workshop, SNA-KDD workshop. Bansal, S., Bhowmick, S., and Paymal, P. (2011). Fast com- munity detection for dynamic complex networks. In Com- plex Networks, pages 196 -- 207. Springer. Barab´asi, A.-L. and Albert, R. (1999). Emergence of scaling in random networks. Science, 286(5439):509 -- 512. Bassett, D. S., Porter, M. A., Wymbs, N. F., Grafton, S. T., Carlson, J. M., and Mucha, P. J. (2013). Robust detection of dynamic community structure in networks. Citation: Chaos, 23. Bazzi, M., Jeub, L. G., Arenas, A., Howison, S. D., and Porter, M. A. (2016). Generative benchmark models for mesoscale structure in multilayer networks. arXiv preprint arXiv:1608.06196. Beck, F., Burch, M., Diehl, S., and Weiskopf, D. (2017). A Taxonomy and Survey of Dynamic Graph Visualization. Computer Graphics Forum, 36(1):133 -- 159. Beir´o, M. G., Busch, J. R., and Alvarez-Hamelin, J. I. (2010). In Latin- Visualizing communities in dynamic networks. 23 American Workshop on Dynamic Networks (LAWDN), pages 4 -- p. Blondel, V. D., Guillaume, J.-L., Lambiotte, R., and Lefeb- vre, E. (2008). Fast unfolding of communities in large net- works. Journal of statistical mechanics: theory and exper- iment, 2008(10):P10008. B´ota, A., Csizmadia, L., and Pluh´ar, A. (2010). Community detection and its use in real graphs. Matcos. B´ota, A., Kr´esz, M., and Pluh´ar, A. (2011). Dynamic commu- nities and their detection. Acta Cybernetica, 20(1):35 -- 52. Bourqui, R., Gilbert, F., Simonetto, P., Zaidi, F., Sharan, U., and Jourdan, F. (2009). Detecting structural changes and command hierarchies in dynamic social networks. In International Conference on Advances in Social Network Analysis and Mining (ASONAM), pages 83 -- 88. IEEE. Boyack, K., Borner, K., and Klavans, R. (2008). Mapping the structure and evolution of chemistry research. Scientomet- rics, 79(1):45 -- 60. Brandes, U., Gaertler, M., and Wagner, D. (2003). Exper- iments on graph clustering algorithms. Algorithms-esa, pages 568 -- 579. Braun, U., Schafer, A., Walter, H., Erk, S., Romanczuk- Seiferth, N., Haddad, L., Schweiger, J. I., Grimm, O., Heinz, A., Tost, H., Meyer-Lindenberg, A., and Bassett, D. S. (2015). Dynamic reconfiguration of frontal brain net- works during executive cognition in humans. Proceedings of the National Academy of Sciences, 112(37):11678 -- 11683. Br´odka, P., Saganowski, S., and Kazienko, P. (2013). Ged: the method for group evolution discovery in social networks. Social Network Analysis and Mining, 3(1):1 -- 14. Casteigts, A., Flocchini, P., Quattrociocchi, W., and Santoro, N. (2012). Time-varying graphs and dynamic networks. In- ternational Journal of Parallel, Emergent and Distributed Systems, 27(5):387 -- 408. Cazabet, R. and Amblard, F. (2011). Simulate to de- tect: a multi-agent system for community detection. In IEEE/WIC/ACM International Conference on Web Intel- ligence and Intelligent Agent Technology (WI-IAT), vol- ume 2, pages 402 -- 408. IEEE. Cazabet, R. and Amblard, F. (2014). Dynamic community detection. In Encyclopedia of Social Network Analysis and Mining, pages 404 -- 414. Springer. Cazabet, R., Amblard, F., and Hanachi, C. (2010). Detection of overlapping communities in dynamical social networks. In 2nd International Conference on Social Computing (So- cialCom), pages 309 -- 314. IEEE. Cazabet, R., Chawuthai, R., and Takeda, H. (2015). Us- ing multiple-criteria methods to evaluate community par- titions. arXiv preprint arXiv:1502.05149. Cazabet, R., Takeda, H., Hamasaki, M., and Amblard, F. (2012). Using dynamic community detection to identify trends in user-generated content. Social Network Analysis and Mining, 2(4):361 -- 371. Chen, Z., Wilson, K. A., Jin, Y., Hendrix, W., and Samatova, N. F. (2010). Detecting and tracking community dynamics in evolutionary networks. In International Conference on Data Mining Workshops (ICDMW), pages 318 -- 327. IEEE. Clauset, A., Newman, M. E., and Moore, C. (2004). Find- ing community structure in very large networks. Physical review E, 70(6):066111. Condon, A. and Karp, R. M. (2001). Algorithms for graph partitioning on the planted partition model. Random Struc- tures and Algorithms, 18(2):116 -- 140. Coscia, M., Giannotti, F., and Pedreschi, D. (2011). A classi- fication for community discovery methods in complex net- works. Statistical Analysis and Data Mining: The ASA Data Science Journal, 4(5):512 -- 546. Crane, H. and Dempsey, W. (2015). Community detection for interaction networks. arXiv preprint arXiv:1509.09254. Crane, H. et al. (2014). The cut-and-paste process. The An- nals of Probability, 42(5):1952 -- 1979. Creusefond, J., Largillier, T., and Peyronnet, S. (2016). On the evaluation potential of quality functions in commu- nity detection for different contexts. In International Con- ference and School on Network Science, pages 111 -- 125. Springer. Danon, L., D´ıaz-Guilera, A., and Arenas, A. (2006). The effect of size heterogeneity on community identification in complex networks. Journal of Statistical Mechanics: The- ory and Experiment, 2006(11):P11010. Dhouioui, Z. and Akaichi, J. (2013). Overlapping community detection in social networks. In International Conference on Bioinformatics and Biomedicine (BIBM), pages 17 -- 23. IEEE. Dhouioui, Z. and Akaichi, J. (2014). Tracking dynamic com- munity evolution in social networks. In IEEE/ACM Inter- national Conference on Advances in Social Networks Anal- ysis and Mining (ASONAM), pages 764 -- 770. IEEE. Duan, D., Li, Y., Jin, Y., and Lu, Z. (2009). Community mining on dynamic weighted directed graphs. In Proceed- ings of the 1st International workshop on Complex Net- works meet Information & Knowledge Management, pages 11 -- 18. ACM. Duan, D., Li, Y., Li, R., and Lu, Z. (2012). Incremental k-clique clustering in dynamic social networks. Artificial Intelligence Review, pages 1 -- 19. Duhan, N., Sharma, A., and Bhatia, K. K. (2009). Page In International Advance ranking algorithms: a survey. Computing Conference (IACC), pages 1530 -- 1537. IEEE. Ester, M., Kriegel, H.-P., Sander, J., Xu, X., et al. (1996). A density-based algorithm for discovering clusters in large spatial databases with noise. In Kdd, volume 96, pages 226 -- 231. Falkowski, T., Bartelheimer, J., and Spiliopoulou, M. (2006). Mining and visualizing the evolution of subgroups in social networks. In IEEE/WIC/ACM International Conference on Web Intelligence (WI), pages 52 -- 58. IEEE. Falkowski, T., Barth, A., and Spiliopoulou, M. (2008). Study- ing community dynamics with an incremental graph mining algorithm. AMCIS 2008 Proceedings, page 29. Falkowski, T. and Spiliopoulou, M. (2007). Data mining for community dynamics. KI, 21(3):23 -- 29. Fan, Y., Li, M., Zhang, P., Wu, J., and Di, Z. (2007). Accu- racy and precision of methods for community identification in weighted networks. Physica A: Statistical Mechanics and its Applications, 377(1):363 -- 372. Ferry, J. P. and Bumgarner, J. O. (2012). Community detec- tion and tracking on networks from a data fusion perspec- tive. arXiv preprint arXiv:1201.1512. Flake, G. W., Lawrence, S., and Giles, C. L. (2000). Efficient identification of web communities. In Proceedings of the sixth ACM SIGKDD international conference on Knowl- edge discovery and data mining, pages 150 -- 160. ACM. Folino, F. and Pizzuti, C. (2010). Multiobjective evolutionary community detection for dynamic networks. In Proceedings of the 12th annual conference on Genetic and evolutionary computation, pages 535 -- 536. ACM. Folino, F. and Pizzuti, C. (2014). An evolutionary multiob- 24 jective approach for community discovery in dynamic net- works. Transactions on Knowledge and Data Engineering, 26(8):1838 -- 1852. Fortunato, S. (2010). Community detection in graphs. Physics reports, 486(3):75 -- 174. Fortunato, S. and Barth´elemy, M. (2007). Resolution limit in community detection. Proceedings of the National Academy of Sciences, 104(1):36 -- 41. Fortunato, S. and Hric, D. (2016). Community detection in networks: A user guide. Physics Reports, 659:1 -- 44. Frishman, Y. and Tal, A. (2004). Dynamic drawing of clus- tered graphs. In Symposium on Information Visualization (INFOVIS), pages 191 -- 198. IEEE. Gaertler, M., Gorke, R., and Wagner, D. (2007). Significance- driven graph clustering. Algorithmic Aspects in Informa- tion and Management, pages 11 -- 26. Gauvin, L., Panisson, A., and Cattuto, C. (2014). Detecting the community structure and activity patterns of tempo- ral networks: a non-negative tensor factorization approach. PloS one, 9(1):e86028. Getoor, L. and Diehl, C. P. (2005). Link mining: a survey. ACM SIGKDD Explorations Newsletter, 7(2):3 -- 12. Ghasemian, A., Zhang, P., Clauset, A., Moore, C., and Peel, L. (2016). Detectability thresholds and optimal algorithms for community structure in dynamic networks. Physical Review X, 6(3):031005. Girvan, M. and Newman, M. E. (2002). Community struc- ture in social and biological networks. Proceedings of the national academy of sciences, 99(12):7821 -- 7826. Gliwa, B., Saganowski, S., Zygmunt, A., Br´odka, P., Kazienko, P., and Kozak, J. (2012). Identification of group changes in blogosphere. In Proceedings of the International Conference on Advances in Social Networks Analysis and Mining (ASONAM), pages 1201 -- 1206. IEEE. Goldberg, M., Magdon-Ismail, M., Nambirajan, S., and Thompson, J. (2011). Tracking and predicting evolution of social communities. In 3rd International Conference on Privacy, Security, Risk and Trust (PASSAT) and 3rd In- ernational Conference on Social Computing (SocialCom), pages 780 -- 783. IEEE. Gong, M.-G., Zhang, L.-J., Ma, J.-J., and Jiao, L.-C. (2012). Community detection in dynamic social networks based on multiobjective immune algorithm. Journal of Computer Science and Technology, 27(3):455 -- 467. Gorke, R., Hartmann, T., and Wagner, D. (2012). Dynamic Graph Clustering Using Minimum-Cut Trees. Journal of Graph Algorithms and Applications, 16(2):411 -- 446. Gorke, R., Maillard, P., Schumm, A., Staudt, C., and Wagner, D. (2013). Dynamic graph clustering combining modular- ity and smoothness. Journal of Experimental Algorithmics (JEA), 18:1 -- 5. Gorke, R., Maillard, P., Staudt, C., and Wagner, D. (2010). SEA, Modularity-driven clustering of dynamic graphs. 6049:436 -- 448. Granell, C., Darst, R. K., Arenas, A., Fortunato, S., and G´omez, S. (2015). Benchmark model to assess commu- nity structure in evolving networks. Physical Review E, 92(1):012805. Greene, D., Doyle, D., and Cunningham, P. (2010). Tracking the evolution of communities in dynamic social networks. In International conference on Advances in Social Networks Analysis and Mining (ASONAM), pages 176 -- 183. IEEE. Guimer`a, R., Sales-Pardo, M., and Amaral, L. A. N. (2007). Module identification in bipartite and directed networks. Physical Review E, 76(3):036102. Guo, C., Wang, J., and Zhang, Z. (2014). Evolutionary community structure discovery in dynamic weighted net- works. Physica A: Statistical Mechanics and its Applica- tions, 413:565 -- 576. Gupta, M., Gao, J., Sun, Y., and Han, J. (2012). Integrat- ing community matching and outlier detection for mining evolutionary community outliers. In Proceedings of the 18th ACM SIGKDD international conference on Knowledge dis- covery and data mining, pages 859 -- 867. ACM. Hartmann, T., Kappes, A., and Wagner, D. (2016). Clus- tering evolving networks. In Algorithm Engineering, pages 280 -- 329. Springer. Henderson, K. and Eliassi-Rad, T. (2009). Applying latent dirichlet allocation to group discovery in large graphs. In Proceedings of the ACM symposium on Applied Computing, pages 1456 -- 1461. ACM. Herlau, T., Mørup, M., and Schmidt, M. N. (2013). Modeling temporal evolution and multiscale structure in networks. In Proceedings of the 30th International Conference on Inter- national Conference on Machine Learning, pages 960 -- 968. Himmel, A.-S., Molter, H., Niedermeier, R., and Sorge, M. (2016). Enumerating maximal cliques in temporal graphs. In IEEE/ACM International Conference on Advances in Social Networks Analysis and Mining (ASONAM), pages 337 -- 344. IEEE. Holme, P. and Saramaki, J. (2012). Temporal networks. Physics reports, 519(3):97 -- 125. Hopcroft, J., Khan, O., Kulis, B., and Selman, B. (2004). Tracking evolving communities in large linked net- works. Proceedings of the National Academy of Sciences, 101(Suppl 1):5249 -- 5253. Hu, Y., Kobourov, S. G., and Veeramoni, S. (2012). Embed- ding, clustering and coloring for dynamic maps. In Pacific Visualization Symposium (PacificVis), pages 33 -- 40. IEEE. Ilhan, N. and Oguducu, S¸. G. (2015). Predicting community evolution based on time series modeling. In Proceedings of the IEEE/ACM International Conference on Advances in Social Networks Analysis and Mining (ASONAM), pages 1509 -- 1516. ACM. Ishiguro, K., Iwata, T., Ueda, N., and Tenenbaum, J. B. (2010). Dynamic infinite relational model for time-varying relational data analysis. In Advances in Neural Information Processing Systems, pages 919 -- 927. Jdidia, M. B., Robardet, C., and Fleury, E. (2007). Commu- nities detection and analysis of their dynamics in collabora- tive networks. In 2nd International Conference on Digital Information Management (ICDIM), volume 2, pages 744 -- 749. IEEE. Kawadia, V. and Sreenivasan, S. (2012). Online detection of temporal communities in evolving networks by estrange- ment confinement. arXiv preprint arXiv:1203.5126, pages 1 -- 21. Kim, M.-S. and Han, J. (2009). A particle-and-density based evolutionary clustering method for dynamic networks. Pro- ceedings of the VLDB Endowment, 2(1):622 -- 633. Kivel, M., Arenas, A., Barthelemy, M., Gleeson, J. P., Moreno, Y., and Porter, M. A. (2014). Multilayer networks. Journal of Complex Networks, 2(3):203 -- 271. Kovanen, L., Karsai, M., Kaski, K., Kert´esz, J., and Saramaki, J. (2011). Temporal motifs in time-dependent networks. Journal of Statistical Mechanics: Theory and Experiment, 2011(11):P11005. 25 Lancichinetti, A. and Fortunato, S. (2009). Benchmarks for testing community detection algorithms on directed and weighted graphs with overlapping communities. Physical Review E, 80(1):016118. Lancichinetti, A., Fortunato, S., and Kert´esz, J. (2009). Detecting the overlapping and hierarchical community structure in complex networks. New Journal of Physics, 11(3):033015. Lancichinetti, A., Fortunato, S., and Radicchi, F. (2008). Benchmark graphs for testing community detection algo- rithms. Physical review E, 78(4):046110. Latapy, M., Viard, T., and Magnien, C. (2017). Stream graphs and link streams for the modeling of interactions over time. arXiv preprint arXiv:1710.04073. Lee, P., Lakshmanan, L. V., and Milios, E. E. (2014). In- cremental cluster evolution tracking from highly dynamic network data. In 30th International Conference on Data Engineering (ICDE), pages 3 -- 14. IEEE. Lee, S., Rocha, L. E., Liljeros, F., and Holme, P. (2012). Ex- ploiting temporal network structures of human interaction to effectively immunize populations. PloS one, 7(5):e36439. Leskovec, J., Kleinberg, J., and Faloutsos, C. (2005). Graphs over time: densification laws, shrinking diameters and possible explanations. In Proceedings of the 11th ACM SIGKDD International Conference on Knowledge Discov- ery in Data Mining, pages 177 -- 187. ACM. Li, X.-L., Tan, A., Philip, S. Y., and Ng, S.-K. (2011). Ecode: event-based community detection from social networks. In International Conference on Database Systems for Ad- vanced Applications (DASFAA), pages 22 -- 37. Springer. Lin, Y.-R., Chi, Y., Zhu, S., Sundaram, H., and Tseng, B. L. (2008). Facetnet: a framework for analyzing communities and their evolutions in dynamic networks. In Proceedings of the 17th international conference on World Wide Web (WWW), pages 685 -- 694. ACM. Lin, Y.-R., Chi, Y., Zhu, S., Sundaram, H., and Tseng, B. L. (2009). Analyzing communities and their evolutions in dy- namic social networks. Transactions on Knowledge Discov- ery from Data (TKDD), 3(2):8. Lin, Y.-R., Sun, J., Cao, N., and Liu, S. (2010). Contex- tour: Contextual contour visual analysis on dynamic multi- relational clustering. In Proceedings of the International Conference on Data Mining, pages 418 -- 429. SIAM. Ma, H.-S. and Huang, J.-W. (2013). Cut: Community update and tracking in dynamic social networks. In Proceedings of the 7th Workshop on Social Network Mining and Analysis, page 6. ACM. Macon, K. T., Mucha, P. J., and Porter, M. A. (2012). Community structure in the united nations general assem- bly. Physica A: Statistical Mechanics and its Applications, 391(1):343 -- 361. Masuda, N. and Lambiotte, R. (2016). A guide to temporal networks, volume 4. World Scientific. Matias, C. and Miele, V. (2016). Statistical clustering of tem- poral networks through a dynamic stochastic block model. Journal of the Royal Statistical Society: Series B (Statisti- cal Methodology). Matias, C., Rebafka, T., and Villers, F. (2015). Estimation and clustering in a semiparametric poisson process stochas- tic block model for longitudinal networks. Matias, C., Rebafka, T., and Villers, F. (2018). A semipara- metric extension of the stochastic block model for longitu- dinal networks. Biometrika, 105(3):665 -- 680. McDaid, A. F., Greene, D., and Hurley, N. (2011). Normal- ized mutual information to evaluate overlapping commu- nity finding algorithms. arXiv preprint arXiv:1110.2515. Miller, K. and Eliassi-Rad, T. (2009). Continuous time group discovery in dynamic graphs. In NIPS Workshop. Milo, R., Shen-Orr, S., Itzkovitz, S., Kashtan, N., Chklovskii, D., and Alon, U. (2002). Network motifs: simple building blocks of complex networks. Science, 298(5594):824 -- 827. Morini, M., Flandrin, P., Fleury, E., Venturini, T., and Jensen, P. (2017). Revealing evolutions in dynamical net- works. arXiv preprint arXiv:1707.02114. Morini, M., Jensen, P., and Flandrin, P. (2015). Temporal evolution of communities based on scientometrics data. In Sciences des donn´ees et humanit´es numeriques. Mucha, P. J., Richardson, T., Macon, K., Porter, M. A., and Onnela, J.-P. (2010). Community structure in time- dependent, multiscale, and multiplex networks. science, 328(5980):876 -- 878. Newbold, P. (1983). Arima model building and the time series analysis approach to forecasting. Journal of Forecasting (pre-1986), 2(1):23. Newman, M. E. (2003). The structure and function of com- plex networks. SIAM review, 45(2):167 -- 256. Newman, M. E. (2004). Fast algorithm for detecting commu- nity structure in networks. Physical review E, 69(6):066133. Newman, M. E. and Girvan, M. (2004). Finding and evalu- ating community structure in networks. Physical review E, 69(2):026113. Nguyen, N. P., Dinh, T. N., Tokala, S., and Thai, M. T. (2011a). Overlapping communities in dynamic networks: their detection and mobile applications. In Proceedings of the 17th annual international conference on Mobile com- puting and networking, pages 85 -- 96. ACM. Nguyen, N. P., Dinh, T. N., Xuan, Y., and Thai, M. T. (2011b). Adaptive algorithms for detecting community structure in dynamic social networks. In 30th International Conference on Computer Communications (INFOCOM), pages 2282 -- 2290. IEEE. Palla, G., Barab´asi, A.-L., and Vicsek, T. (2007). Quantifying social group evolution. Nature, 446(7136):664 -- 667. Palla, G., Der´enyi, I., Farkas, I., and Vicsek, T. (2005). Un- covering the overlapping community structure of complex networks in nature and society. Nature, 435(7043):814 -- 818. Peel, L. and Clauset, A. (2015). Detecting change points in In AAAI, the large-scale structure of evolving networks. pages 2914 -- 2920. Peel, L., Larremore, D. B., and Clauset, A. (2017). The ground truth about metadata and community detection in networks. Science Advances, 3(5):e1602548. Pons, P. and Latapy, M. (2006). Computing communities in large networks using random walks. J. Graph Algorithms Appl., 10(2):191 -- 218. Radicchi, F., Castellano, C., Cecconi, F., Loreto, V., and Parisi, D. (2004). Defining and identifying communities in networks. Proceedings of the National Academy of Sciences of the United States of America, 101(9):2658 -- 2663. Reda, K., Tantipathananandh, C., Johnson, A., Leigh, J., and Berger-Wolf, T. (2011). Visualizing the evolution of com- munity structures in dynamic social networks. In Computer Graphics Forum, volume 30, pages 1061 -- 1070. Wiley On- line Library. R´enyi, A. and Erdos, P. (1959). On random graphs. Publica- tiones Mathematicae, 6(290-297):5. Rossetti, G. (2015). Social Network Dynamics. PhD thesis, Computer Science Dept. University of Pisa. 26 Rossetti, G. (2017). Rdyn: Graph benchmark handling com- munity dynamics. Journal of Complex Networks. Rossetti, G., Guidotti, R., Pennacchioli, D., Pedreschi, D., and Giannotti, F. (2015). Interaction prediction in dynamic networks exploiting community discovery. In Proceedings of the IEEE/ACM International Conference on Advances in Social Networks Analysis and Mining (ASONAM), pages 553 -- 558. ACM. Rossetti, G., Pappalardo, L., Pedreschi, D., and Giannotti, F. (2017). Tiles: an online algorithm for community dis- covery in dynamic social networks. Machine Learning, 106(8):1213 -- 1241. Rossetti, G., Pappalardo, L., and Rinzivillo, S. (2016). A novel approach to evaluate community detection algorithms on ground truth. In Complex Networks VII, pages 133 -- 144. Springer. Rosvall, M. and Bergstrom, C. T. (2010). Mapping change in large networks. PloS one, 5(1):e8694. Saganowski, S., Gliwa, B., Br´odka, P., Zygmunt, A., Kazienko, P., and Ko´zlak, J. (2015). Predicting community evolution in social networks. Entropy, 17(5):3053 -- 3096. Sawardecker, E. N., Sales-Pardo, M., and Amaral, L. A. N. (2009). Detection of node group membership in networks with group overlap. The European Physical Journal B- Condensed Matter and Complex Systems, 67(3):277 -- 284. Schlitter, N. and Falkowski, T. (2009). Mining the dynam- ics of music preferences from a social networking site. In International Conference on Advances in Social Network Analysis and Mining (ASONAM), pages 243 -- 248. IEEE. Shang, J., Liu, L., Xie, F., Chen, Z., Miao, J., Fang, X., and Wu, C. (2014). A real-time detecting algorithm for tracking community structure of dynamic networks. arXiv preprint arXiv:1407.2683. Shao, J., Han, Z., and Yang, Q. (2014). Community de- arXiv preprint tection via local dynamic interaction. arXiv:1409.7978. Shi, J. and Malik, J. (2000). Normalized cuts and image seg- mentation. Transactions on pattern analysis and machine intelligence, 22(8):888 -- 905. Sun, J., Faloutsos, C., Papadimitriou, S., and Yu, P. S. (2007). Graphscope: parameter-free mining of large time-evolving graphs. In Proceedings of the 13th ACM SIGKDD interna- tional conference on Knowledge discovery and data mining, pages 687 -- 696. ACM. Sun, Y., Tang, J., Han, J., Chen, C., and Gupta, M. (2014). Co-evolution of multi-typed objects in dynamic star net- works. Transactions on Knowledge and Data Engineering (TKDE), 26(12):2942 -- 2955. Sun, Y., Tang, J., Han, J., Gupta, M., and Zhao, B. (2010). Community evolution detection in dynamic heterogeneous information networks. In Proceedings of the Eighth Work- shop on Mining and Learning with Graphs, pages 137 -- 146. ACM. Tabourier, L., Libert, A.-S., and Lambiotte, R. (2016). Pre- dicting links in ego-networks using temporal information. EPJ Data Science, 5(1):1. Takaffoli, M., Sangi, F., Fagnan, J., and Zaıane, O. R. (2011). Modec-modeling and detecting evolutions of communities. In 5th International Conference on Weblogs and Social Me- dia (ICWSM), pages 30 -- 41. AAAI. Tan, B., Zhu, F., Qu, Q., and Liu, S. (2014). Online community transition detection. In International Confer- ence on Web-Age Information Management, pages 633 -- 644. Springer. 27 evolutions in dynamic social networks. In Proceedings of the International Conference on Data Mining, pages 990 -- 1001. SIAM. Yang, T., Chi, Y., Zhu, S., Gong, Y., and Jin, R. (2011). Detecting communities and their evolutions in dynamic so- cial networks -- a bayesian approach. Machine learning, 82(2):157 -- 189. Zakrzewska, A. and Bader, D. A. (2015). A dynamic algo- rithm for local community detection in graphs. In Pro- ceedings of the 2015 IEEE/ACM International Confer- ence on Advances in Social Networks Analysis and Mining (ASONAM), pages 559 -- 564. ACM. Zhou, D., Councill, I., Zha, H., and Giles, C. L. (2007). Dis- covering temporal communities from social network docu- ments. In 7th International Conference on Data Mining (ICDM), pages 745 -- 750. IEEE. Tang, L., Liu, H., Zhang, J., and Nazeri, Z. (2008). Commu- nity evolution in dynamic multi-mode networks. In Proceed- ings of the 14th ACM SIGKDD international conference on Knowledge discovery and data mining, pages 677 -- 685. ACM. Tantipathananandh, C., Berger-Wolf, T., and Kempe, D. (2007). A framework for community identification in dy- namic social networks. In Proceedings of the 13th ACM SIGKDD international conference on Knowledge discovery and data mining, pages 717 -- 726. ACM. Van Nguyen, M., Kirley, M., and Garc´ıa-Flores, R. (2012). Community evolution in a scientific collaboration network. In Congress on Evolutionary Computation (CEC), pages 1 -- 8. IEEE. Vehlow, C., Beck, F., Auwarter, P., and Weiskopf, D. (2015a). Visualizing the evolution of communities in dy- namic graphs. In Computer Graphics Forum, volume 34, pages 277 -- 288. Wiley Online Library. Vehlow, C., Beck, F., and Weiskopf, D. (2015b). The state of the art in visualizing group structures in graphs. In Eu- rographics Conference on Visualization (EuroVis)-STARs, volume 2. The Eurographics Association. Vehlow, C., Beck, F., and Weiskopf, D. (2016). Visual- izing Dynamic Hierarchies in Graph Sequences. IEEE Transactions on Visualization and Computer Graphics, 22(10):2343 -- 2357. Viard, T., Latapy, M., and Magnien, C. (2016). Comput- ing maximal cliques in link streams. Theoretical Computer Science, 609:245 -- 252. Wang, Y., Wu, B., and Pei, X. (2008). Commtracker: A core-based algorithm of tracking community evolution. Ad- vanced Data Mining and Applications, pages 229 -- 240. Watts, D. J. and Strogatz, S. H. (1998). Collective dynamics of small-worldnetworks. Nature, 393(6684):440 -- 442. Xie, J., Chen, M., and Szymanski, B. K. (2013a). Labelrankt: Incremental community detection in dynamic networks via label propagation. In Proceedings of the Workshop on Dy- namic Networks Management and Mining, pages 25 -- 32. ACM. Xie, J., Kelley, S., and Szymanski, B. K. (2013b). Overlapping community detection in networks: The state-of-the-art and comparative study. ACM Computing Surveys, 45(4):43. Xie, J. and Szymanski, B. K. (2013). Labelrank: A stabi- lized label propagation algorithm for community detection in networks. In 2nd Network Science Workshop (NSW), pages 138 -- 143. IEEE. Xu, H., Wang, Z., and Xiao, W. (2013a). Analyzing commu- nity core evolution in mobile social networks. In Interna- tional Conference on Social Computing (SocialCom), pages 154 -- 161. IEEE. Xu, H., Xiao, W., Tang, D., Tang, J., and Wang, Z. (2013b). Community core evolution in mobile social networks. The Scientific World Journal, 2013. Xu, K. S. and Hero, A. O. (2014). Dynamic stochastic block- models for time-evolving social networks. Journal of Se- lected Topics in Signal Processing, 8(4):552 -- 562. Yang, J. and Leskovec, J. (2014). Structure and overlaps of ground-truth communities in networks. Transactions on Intelligent Systems and Technology (TIST), 5(2):26. Yang, J. and Leskovec, J. (2015). Defining and evaluating network communities based on ground-truth. Knowledge and Information Systems, 42(1):181 -- 213. Yang, T., Chi, Y., Zhu, S., Gong, Y., and Jin, R. (2009). A bayesian approach toward finding communities and their In this section, we propose a brief description for each DCD method we have identified in the literature, fram- ing them in the proposed taxonomy. When possible, we contacted the authors to validate our description. Inside categories, methods are ordered chronologically. VIII. INSTANT-OPTIMAL COMMUNITY DISCOVERY Here are collected and classified all the works introduc- ing approaches falling in the Instant-optimal class. For details on the class definition and peculiarities refer to Section IV.A. A. Iterative similarity-based approaches 28 identify communities in the network but also its pivots (vertices shared by several clusters) while being insensitive to minor changes in the network; 3. Major structural changes in the network are de- tected by comparing the clustering obtained on ev- ery pair of successive static graphs using a similar- ity measure (cluster representativeness, e.g., the ge- ometrical mean of the normalized ratio of common elements between two clusters). Thus, the tempo- ral changes in the input network are decomposed into periods of high activity and consensus com- munities during stable periods; 4. An influence hierarchy in the consensus communi- ties is identified using an MST (Minimum Spanning Tree). The algorithm in (Hopcroft et al., 2004) can be seen as the ancestor of all approaches within this category. It first finds "natural communities" in each snapshot by running the same algorithm for community detection sev- eral times and maintaining only those communities that appear in most runs. In a second phase, similar commu- nities of successive snapshots are matched together using a match function defined as: match(C, C(cid:48)) = M in (cid:18)C ∩ C(cid:48) (cid:19) , C ∩ C(cid:48) C(cid:48) C with C and C(cid:48) the clusters to compare treated as sets. The algorithm proposed in (Palla et al., 2007) is based on clique percolation (CPM (Palla et al., 2005)). CPM is applied on each snapshot to find communities. The matching between these communities is done by running CPM on the joint graph of snapshots at t and t + 1. Due to the formal definition of communities pro- vided by CPM (communities are composed of cliques), communities of the joint graph can only grow compared to those of both snapshots. The authors also discuss how the knowledge of the temporal commitment of members to a given community can be used for estimating the community's lifetime. They observed that while the stability of small communities is ensured by the high homogeneity of the nodes involved, for large ones the key of a long life is continuous change. In (Bourqui et al., 2009), an approach based on dynamic graph discretization and graph clustering is proposed. The framework allows detection of major structural changes over time, identifies events by analyz- ing temporal dimensions and reveals hierarchies in social networks. It consists of four major steps: 1. The social network is decomposed into a set of snapshot graphs; 2. Clusters are extracted from each static graph sepa- rately using an overlapping CD algorithm, to pro- duce overlapping structures. This step allows to In (Asur et al., 2009), the authors approach the problem of identifying events in communities: MCL (a modular- ity based algorithm) is applied to extract communities in each time step. A set of events (Continue, kMerge, kSplit, Form, Dissolve, Join, Leave) are defined. For in- stance, kMerge is defined as: kM erge(C k i, k) = 1 iff ∃C j i , C l i+1 such that (V k i ∪ V l i ∪ V l M ax(V k Ck i and V k i+1 > 2 representing time steps. i ∩ V j > k% i ) ∩ V j i+1 i ,V j i+1) i ∩ V j and V l i+1 > Cl i 2 , with i In (Rosvall and Bergstrom, 2010), the authors propose a method to map changes in large networks. To do so, they focus on finding stable communities for each snapshot, by using a bootstrap resampling procedure accompanied by significance clustering. More precisely, for each snapshot, 1000 variations of the original network are generated, in which the weight of each edge is taken randomly from a Poisson distribution having as mean the original weight of the edge. All of these alternative networks are clustered using a static algorithm. To find significant communities, the authors propose to search for modules, largest sets of nodes that are clustered together in more than 95% of networks. These small node sets are grouped into larger clusters if their nodes appear together in more than 5% of network instances. Clusters corre- sponding to different time steps are linked if the number of common nodes is higher than a user-defined threshold. In (B´ota et al., 2011), the authors propose an ex- tension of the basic community events described in (Palla et al., 2007) and an approach capable of handling communities identified by a non-monotonic community detection algorithm (N ++ (B´ota et al., 2010)). The proposed method works on snapshots and uses for each pair of adjacent network observation union (and intersection) graphs to perform community matching. The final goal of this approach is to build an extended community life-cycle. In addition to the classical events defined in (Palla et al., 2007), 5 meta-events are introduced to capture the combinations of standard events: Grow-merge, Contraction-merge, Grow-split, Contraction-split and Obscure case (which envelop more complex, non-binary, transformations). The method proposed in (Takaffoli et al., 2011) is designed to track the evolution of communities. First, a static community detection is run on each snapshot, using an existing algorithm. In a second step, commu- nities matching and operations are done according to a set of rules, that can be summarized as: • Two communities are matched if they have at least a fraction k of the nodes of the largest one in com- mon; • A new community is born if it has no match in the previous snapshot; • A community dies if it has no match in the following snapshot; • A community split if several other communities 29 in different snapshots. A Data Warehouse layer memo- rizes the evolution of the network and its communities. In (Ilhan and Oguducu, 2015) an evolving network is represented by a series of static snapshots. Com- munities are determined using the Louvain algorithm (Blondel et al., 2008), then matched using a custom similarity metric. The evolution of communities is labeled with the events they experienced (survive, grow, shrink, merge, split and dissolve). Moreover, the authors propose to forecast future evolution of communities. To do so, a broad range of structural and temporal features are extracted covering many properties of both the internal link structure and the external interaction of each community with the rest of the network. A temporal window length is defined to generate time series for each feature, thus for each community, a set of time-series is built. Then, ARIMA (Auto Regressive Integrated Moving Average) model (Newbold, 1983) is applied to estimate the next values of the features. The communities with the forecasted feature values were then used as test set for several classification algorithms trained using the rest of the window length snapshots as the training set. have more than a fraction k of its nodes; B. Iterative core-nodes based approaches • A merge occurs if a community contains at least a fraction k of several other communities. The method proposed in (Greene et al., 2010) is designed to track the evolution of communities in time evolving graphs following a two-step approach: (i) community detection is executed on each snapshot with a chosen static algorithm and then (ii) the Jaccard coefficient is used to match communities across adjacent snapshots. Communities are matched if their similarity is above a user-defined threshold, allowing many-to- many mappings. The GED method, proposed in (Br´odka et al., 2013), is designed to identify what happened to each node-group in successive time frames: it uses not only the size and equivalence of groups' members but also takes into account their position (e.g., via node ranking within communities, social position. . . ) and importance within the group. This approach is sustained by a new measure called inclusion, which respects both the quantity (the number of members) and quality (the importance of members) of the group. The proposed framework is parametric in the static CD algorithm to be applied on each network snapshot to extract node-groups (commu- nities). The method proposed in (Dhouioui and Akaichi, 2014) uses the OCDA algorithm (Dhouioui and Akaichi, 2013) to find overlapping communities in each snapshot. Then, relations are found between similar communities The method described in (Wang et al., 2008) proposes to use the concept of core nodes to track the evolution of communities. It is agnostic w.r.t. the CD algorithm used to detect communities on each snapshot. For each snapshot, a voting strategy is used to select a few core nodes. Finally, the tracking of communities can be done by tracking the core nodes. In (Chen et al., 2010), the authors adopt a conser- vative definition of communities, i.e., they define them as the maximal cliques of the graph. They consequently introduce Graph representatives and Community repre- sentatives to limit the search space and avoid redundant communities. They are defined as follows: • Graph representatives: Representatives of graph Gt are the nodes that also appear in Gt1, Gt+1,or both. Nodes that only appear in one graph are called graph dependent nodes. If a community only contains graph-dependent vertices, then it can be considered as a "graph-dependent" community, not dynamic one • Community representatives: A community repre- sentative of community C t i that i has the minimum number of appearances in other communities of the same graph Gt. is a node in C t The proposed approach first finds graph representatives and enumerates the communities that are seeded by the graph representatives to avoid considering redundant communities. Then, in every generated community, it se- lects only one node as a community representative and uses community representatives to establish the predeces- sor/successor relationship between communities of differ- ent time-steps. Once all predecessors and successors have been found, it finally applies decision rules to determine community dynamics. IX. TEMPORAL TRADE-OFF COMMUNITIES DISCOVERY Here are collected and classified all the works introduc- ing approaches falling in the Temporal Trade-off class. For details on the class definition and peculiarities refer to Section IV.B. 30 C. Multi-step matching A. Partition update by Global optimization In (Falkowski et al., 2006; Falkowski and Spiliopoulou, 2007), a three-step approach is applied to detect sub- groups in social networks: 1. In the first step, communities are found in each snapshot using a static CD algorithm. 2. In the second step, communities in different snap- shots are linked based on their similarity, using the min(x,y) . This overlap measure: overlap(x, y) = creates a Community survival graph. x(cid:84) y 3. In the third step, a community detection algorithm is run on the Community survival graph, thus find- ing communities relevant across several snapshots. The approach proposed in (Goldberg et al., 2011) identifies evolutive chains of communities. Given a time- evolving graph, community detection on each snapshot is executed using a chosen static algorithm (including overlapping ones). Any set intersection based measure can be used to match communities between snapshots, creating a link between them. The authors propose a strategy to find the best chains of evolution for each community: they define chain strength as the strength of its weakest link. As a result, all the maximal valid chains are constructed for the identified communities. A valid chain is considered maximal if it is not a proper subchain of some other valid chain. In (Morini et al., 2017), the authors start by com- puting aggregated network snapshots from timestamped observations (SN or TN) using sliding windows. Com- munities are detected using a static CD algorithm on each of these windows independently. Then, the similarity between pair of communities is computed between communities at t and communities at t − 2, t − 1, t + 1, t + 2. This information is used to smooth if a community ct−n out the evolution of communities: in a previous snapshot has a high similarity with ct+n in a later one, but is matched with lower similarity to two communities c1t and c2t at t, then these two communities are merged and the resulting community is identified to ct−n and ct+n. The same mechanism is used to smooth out artificial merges. In (Miller and Eliassi-Rad, 2009), the authors adapt a dynamic extension of Latent Dirichlet Allocation to the extraction of dynamic communities. They design cDTM-G the "continuous time Dynamic Topic Model for Graphs". In this work, observations of the time evolving graph (snapshots) correspond to corpora at different points in time: each source-node at each time step corresponds to a document at the same time step, and the links among the nodes connect document's words. Exploiting such modeling strategy, dynamic groups/communities topics. The authors sequentially run LDA-G (Henderson and Eliassi-Rad, 2009) on each time step initializing the topics for the current time step with the ones learned in the previous time step. evolving capture time The method proposed in (Aynaud and Guillaume, 2010) is based on the Louvain algorithm. In the original, static version, the Louvain algorithm is initialized with each node in its community. A greedy, multi-step heuris- tic is used to move nodes to optimize the partition's modularity. To limit instability, the authors propose to initialize the Louvain algorithm at t by communities found at t − 1. A parameter x ∈ [0 − 1] can be tuned to specify a random fraction of nodes that will start in a singleton community, to avoid staying in a local minimum (community drift). The algorithm proposed in (Gorke et al., 2010) ef- ficiently maintains a modularity-based clustering of a graph for which dynamic changes arrive as a stream. The authors design dynamic generalizations of two modularity maximization algorithms, (Clauset et al., 2004) and (Blondel et al., 2008). The problem is cast as an ILP (Integer Linear Programming). Intuitively, the process at t is initialized by communities found at t − 1, adding a backtracking strategy to extend the search space. In (Bansal et al., 2011), the authors introduce a dynamic community detection algorithm for real-time online changes, which involves the addition or deletion of edges in the network. The algorithm, based on the greedy agglomerative technique of the CNM algorithm (Clauset et al., 2004), follows a hierarchical clustering approach, where two communities are merged at each step to optimize the increase in the modularity of the network. The proposed improvement for the dynamic case consists in starting from the dendrogram of the previous step cutted just before the first merge of a node involved in the network modifications. It assumes that the small change in network size and density between snapshots does not dramatically impact modularity for non-impacted nodes, and therefore that the beginning of the dendrogram is not impacted. The method proposed in (Shang et al., 2014) searches for evolving communities of maximal modularity. The Louvain algorithm (Blondel et al., 2008) is used to find communities in the first snapshot. Custom rules are then applied to each modification of the network to update the communities while keeping the modularity as high as possible. The procedure designed to update the communities depends on the type of modification of the network, which can concern an inner community edge, across community edge, a half-new edge (if one of the involved nodes is new) or a new edge (if both extremities are new nodes). (Alvari et al., 2014) The authors of introduce a game-theoretic approach for community detection in dynamic social networks called D-GT: in this context, each node is treated as a rational agent who periodically chooses from a set of predefined actions to maximize its utility function. The community structure of a snapshot emerges after the game reaches Nash equilibrium: the partitions and agent information are then transferred to the next snapshot. D-GT attempts to simulate the decision-making process of the individuals creating com- munities, rather than focusing on statistical correlations between labels of neighboring nodes. B. Informed CD by Multi-objective optimization In (Zhou et al., 2007), the authors seek communities in bipartite graphs. Temporal communities are discovered by threading the partitioning of graphs in different periods, using a constrained partitioning algorithm. Communities for a given snapshot are discovered by optimizing the Normalized cut. The discovery of community structure at time t seeks to minimize the (potentially weighted) sum of distances between the current and n previous community membership, n being a parameter of the algorithm. The approach proposed in (Tang et al., 2008) al- lows finding the evolution of communities in multi-mode networks. To find communities at time t, the authors propose to use a spectral-based algorithm that minimize a cost function defined as the sum of two parts, F1 and Ω. F1 corresponds to the reconstruction error of a model similar to block modeling but adapted to multi-mode networks. Ω is a regulation term that states the difference between the current clustering and the 31 previous one. Weights allow balancing the relative importance of these two factors. In (Yang et al., 2009, 2011), the authors propose to use a Dynamic Stochastic Block Model. As in a typical static SBM, nodes belong to clusters, and an interaction probability βql is assigned to each pair of clusters (q, l). The dynamic aspect is handled by a tran- sition matrix, that determines the probability for nodes belonging to a cluster to move to each other cluster at each step. The optimal parameters of this model are searched for using a custom Expectation-Maximization (EM) algorithm. The βql are constant for the same community for all time steps. Two versions of the framework are discussed: • online learning which updates the probabilistic model iteratively (in this case, the method is a Tem- poral Trade-Off CD, similar to FacetNet (Lin et al., 2009)); • offline learning which learns the probabilistic model with network data obtained at all time steps (in this case, the method is a Cross-Time CD, see appropriate section). The method discussed in (Folino and Pizzuti, 2010, 2014) adopt a genetic algorithm to optimize a multi- objective quality function. One objective is to maximize the quality of communities in the current snapshot (the modularity is used in the article, but other metrics such as conductance are proposed). The other objective regards the maximization of the NMI between the communities of the previous step and of the current one to ensure a smooth evolution. In FacetNet, introduced in (Lin et al., 2008, 2009), the authors propose to find communities at t. To minimize the reconstruction error, a cost error defined as cost = αC1 + (1 − α)C2 is defined -- with C1 correspond- ing to the reconstruction error of a mixture model at t, and C2 corresponding to the KL-divergence between clustering at t and clustering at t − 1. The authors then propose a custom algorithm to optimize both parts of the cost function. This method is similar to (Yang et al., 2009). The method described in (Sun et al., 2014, 2010) proposes to find multi-typed communities in dynamic heterogeneous networks. A Dirichlet Process Mixture Model-based generative model is used to model the com- munity generations. A Gibbs sampling-based inference algorithm is provided to infer the model. At each time step, the communities found are a trade-off between the best solution at t and a smooth evolution compared to the solution at t − 1. In (Gong et al., 2012), the detection of community structure with temporal smoothness is formulated as a multi-objective optimization problem. As in (Folino and Pizzuti, 2010, 2014) the maximization is performed on modularity and NMI. In (Kawadia and Sreenivasan, 2012) a new measure of partition distance is introduced. Estrangement captures the inertia of inter-node relationships which, when incorporated into the measurement of partition quality, facilitates the detection of temporal communities. Upon such measure is built the estrangement confinement method, which postulates that neighboring nodes in a community prefer to continue to share community affiliation as the network evolves. The authors show that temporal communities can be found by estrangement constrained modularity maximization, a problem they solve using Lagrange duality. Estrangement can be decomposed into local single node terms, thus enabling an efficient solution of the Lagrange dual problem through agglomerative greedy search methods. In (Crane and Dempsey, 2015) is introduced a hid- den Markov model for inferring community structures that vary over time according to the cut-and-paste dynamics from (Crane et al., 2014). The model takes advantage of temporal smoothness to reduce short-term irregularities in community extraction. The partition obtained is without overlap, and the network population is fixed in advance (no node appearance/vanishing). In (Gorke et al., 2013) is proposed an algorithm to efficiently maintain a modularity-based clustering of a graph for which dynamic changes arrive as a stream, similar to (Gorke et al., 2012). Differently from such work, here the authors introduce an explicit trade-off between modularity maximization and similarity to the previous solution, measured by the Rand index. As in other methods, a parameter α allows to tune the importance of both components of this quality function. C. Partition update by set of rules DENGRAPH (Falkowski et al., 2008) is an adaptation of the data clustering technique DBSCAN (Ester et al., 1996) for graphs. A function of proximity ranging in [0,1] is defined to represent the distance between each pair of vertices. A vertex v is said to be density-reachable from a core vertex c if and only if the proximity between v and c is above a parameter ω. A core vertex is defined as a vertex that has more than η density-reachable vertices. Communities are defined by the union of core vertices that are density-reachable from each other. A simple procedure is defined to update the communities following each addition or removal of an edge. AFOCS (Adaptative FOCS), described in (Nguyen et al., 2011a), uses the FOCS algorithm to find initial communities. Communities found by FOCS are dense 32 subgraphs, that can have strong overlaps. Starting from such topologies, a local procedure is applied to update the communities at each modification of the network (e.g., addition or removal of a node or an edge). The strategy, proposed to cope with local network modifications, respects the properties of communities as they are defined by the FOCS algorithm. In (Cazabet et al., 2010), is introduced iLCD, an incremental approach able to identify and track dynamic communities of high cohesion. Two measures are defined to qualify the cohesion of communities: • EMSN: the Estimation of the mean number of sec- ond neighbors in the community; • EMRSN: the Estimation of the mean number of robust second neighbors (second neighbors that can be accessed by at least 2 different paths). Given a new edge, the affected nodes can join an existing community if an edge appeared with a node in this community. The condition is that the number of its second neighbors in the community is greater than the value of EMSN of the community, and respectively for EMRSN. iLCD has two parameters k and t. The former regulates the rising of new communities (new communities are created if a new clique of size k appears outside of existing ones), while the latter the merge of existing ones (communities can be merged if their similarity becomes greater than a threshold t). In (Nguyen et al., 2011b), the Quick Community Adaptation (QCA) algorithm is introduced. QCA is a modularity-based method for identifying and tracking community structure of dynamic online social networks. The described approach efficiently updates network com- munities, through a series of changes, by only using the structures identified from previous network snapshots. Moreover, it traces the evolution of community structure over time. QCA first requires an initial community structure, which acts as a basic structure, to process network updates (node/edge addition/removal). In (Cazabet and Amblard, 2011), the authors pro- pose to use a multi-agent system to handle the evolution of communities. The network is considered as an environment, and communities are agents in this en- vironment. When what they perceive of their local environment addition/removal), community agents take decisions to add/lose nodes or merge with another community, based on a set of rules. These rules are based on three introduced measures, representativeness, seclusion and potential belonging. (edge/node change In (Agarwal et al., 2012) the authors addressed the problem of discovering events in a microblog stream. To this extent, they mapped the problem of finding events to that of finding clusters in a graph. The authors describe aMQCs: bi-connected clusters, satisfying short- cycle property that allow them to find and maintain the clusters locally without affecting their quality. Network dynamics are handled through a rule-based approach for addition/deletion of nodes/edges. social networks' dynamics In (Duan et al., 2012) are modeled as a change stream. Based on this model, a local DFS forest updating algorithm is proposed for incremental 2-clique clustering, and it is generalized to incremental k-clique clustering. The incremental strategies are designed to guarantee the accuracy of the clustering result with respect to any kind of changes (i.e., edge addition/deletion). Moreover, the authors shown how the local DFS forest updating algorithm produces not only the updated connected components of a graph but also the updated DFS forest, which can be applied to other issues, such as finding a simple loop through a node. In (Gorke et al., 2012), the authors show that the structure of minimum-s-t-cuts in a graph allow for an efficient dynamic update of minimum-cut trees. The authors proposed an algorithm that efficiently updates specific parts of such a tree and dynamically maintains a graph clustering based on minimum-cut trees under arbitrary atomic changes. The main feature of the graph clustering computed by this method is that it is guaranteed to yield a certain expansion -- a bottleneck measure -- within and between clusters, tunable by an input parameter α. The algorithm ensures that its community updates handle temporal smoothness, i.e., changes to the clusterings are kept at a minimum, whenever possible. The CUT algorithm, introduced in (Ma and Huang, 2013), tracks community-seeds to update community structures instead of recalculating them from scratch as time goes by. The process is decomposed into two steps: 33 The method described in (Lee et al., 2014) aims at monitoring the evolution of a graph applying a fading time window. The proposed approach maintains a skeletal graph that summarizes the information in the dynamic network. Communities are defined as the connected components of such this skeletal graph. Com- munities on the original graphs are built by expanding the ones found on the skeletal graph. In (Zakrzewska and Bader, 2015), the authors propose an algorithm for dynamic greedy seed set expansion, which incrementally updates the traced community as the underlying graph changes. The algorithm incre- mentally updates a local community starting from an initial static network partition (performed trough a classic set seed expansion method). For each update, the algorithm modifies the sequence of community members to ensure that corresponding fitness scores are increasing. the authors In (Rossetti et al., 2017), introduce TILES5, an online algorithm that dynamically tracks communities in an edge stream graph following local topology perturbations. Exploiting local patterns and constrained label propagation, the proposed algorithm reduces the computation overhead. Communities are defined as two-level entities: • Core node: a core node is defined as a node involved in at least a triangle with other core nodes of the same community; • Community Periphery: the set of all nodes at one- hop from the community core. Event detection is also performed at runtime (Birth, Split, Merge, Death, Expansion, Contraction). 1. First snapshot: identify community seeds (collec- D. Informed CD by network smoothing tion of 3-cliques); 2. Successive snapshots: (i) track community seeds and update them if changes occur, (ii) expand com- munity seeds to complete communities. To easily track and update community seeds, CUT builds up a Clique Adjacent Bipartite graph (CAB). Custom, policies are then introduced to handle node/edge join/removal and seed community expansion. In (Xie et al., 2013a), the LabelRankT algorithm is introduced. It is an extension of LabelRank (Xie and Szymanski, 2013), an online distributed algorithm for the detection of communities in large-scale dynamic networks through stabilized label propagation. Label- RankT takes advantage of the partitions obtained in previous snapshots for inferring the dynamics in the current one. In (Kim and Han, 2009), the authors propose a particle-and-density based method, for efficiently dis- covering a variable number of communities in dynamic networks. The method models a dynamic network as a collection of particles called nano-communities, and model communities as a densely connected subset of such particles. Each particle, to ensure the identification of dense substructures, contains a small amount of in- formation about the evolution of neighborhoods and/or communities and their combination, both locally and across adjacent network snapshots (which are connected as t-partite graphs). To allow flexible and efficient temporal smoothing, a cost embedding technique -- independent on both the similarity measure and the 5 TILES code available at: https://goo.gl/zFRfCU 34 clustering algorithm used -- is proposed. In this work is also proposed a mapping method based on information theory. on dynamic directed weighted graphs (DDWG). Stream- Group relies on a two-step approach to discover the community structure in each time-slice: The method proposed in (Guo et al., 2014) finds communities in each dynamic weighted network snap- shot using modularity optimization. For each new snapshot, an input matrix -- which represents a tradeoff between the adjacency matrix of the current step and the adjacency matrix of the previous step -- is computed. Then, a custom modularity optimization community detection algorithm is applied. In (Xu et al., 2013a,b), the Cumulative Stable Contact (CSC) measure is proposed to analyze the relationship among nodes: upon such measure, the authors build an algorithm that tracks and updates stable communities in mobile social networks. The key definition provided in this work regards: • Cumulative Stable Contact: There is a CSC be- tween two nodes iff their history contact duration is higher than a threshold. • Community Core Set: The community core at time t is a partition of the given network built upon the useful links rather than on all interactions. The network dynamic process is divided into snapshots. Nodes and their connections can be added or removed at each snapshot, and historical contacts are considered to detect and update Community Core Set. Commu- nity cores are tracked incrementally allowing to recognize evolving community structures. X. CROSS-TIME COMMUNITIES DISCOVERY Here are collected and classified all the works intro- ducing approaches falling in the Cross-Time class. For details on the class definition and peculiarities refer to Section IV.C. A. Fixed Memberships, fixed properties GraphScope (Sun et al., 2007) is an algorithm de- signed to find communities in dynamic bipartite graphs. Based on the Minimum Description Length (MDL) principle, it aims is to optimize graph storage while performing community analysis. Starting from an SN, it reorganizes snapshots into segments. Given a new incoming snapshot it is combined with the current segment if there is a storage benefit, otherwise, the current segment is closed, and a new one is started with the new snapshot. The detection of communities sources and destination for each segment is done using MDL. In (Duan et al., 2009) the authors introduce a method called Stream-Group designed to identify communities 1. The first step constructs compact communities ac- cording to each node's single compactness -- a mea- sure which indicates the degree a node belongs to a community in terms of the graph's relevance ma- trix. 2. In the second step, compact communities are merged along the direction of maximum increase of the modularity. A measure of the similarity between partitions is then used to determine whether a change-point appears along the time axis and an incremental algorithm is designed to update the partition of a graph segment when adding a new arriving graph into the graph segment. In detail, when a new time-slice arrives, 1. the community structure of the arriving graph is computed; 2. the similarity between the partition of the new ar- riving graph and that of the previous graph seg- ment is evaluated; 3. change-point detection is applied: if the time-slice t is not a change point, then 4. the partition of the graph is updated; otherwise a new one is created. In (Aynaud and Guillaume, 2011), the authors pro- pose a definition of average modularity Qavg over a set of snapshots (called time window), defined as a weighted average of modularity for each snapshot, with weights de- fined a priori -- for instance to reflect heterogeneous du- rations. Optimizing average modularity yield a constant partition relevant overall considered snapshots. This ap- proach does not contemplate community operations. The authors propose two methods to optimize this modularity: • Sum-method : Given an evolving graph G = {G1, G2, . . . , Gn} and a time window T ⊆ {1, . . . , n}, a cumulative weighted graph is built, called the sum graph, which is the union of all the snapshots in T . Each edge of the sum graph is weighted by the total time during which this edge exists in T . Since the sum graph is a static weighted graph, the authors apply the Louvain method (Blondel et al., 2008) on it. This method is not strictly equivalent to optimizing Qavg but allows a fast approximation. • Average-Method : two elements of the Louvain method (Blondel et al., 2008) are changed to op- timize the average modularity during a time win- dow T : (1) the computation of the quality gain in the first phase and (2) how to build the network between communities in the second one. 1. average modularity gain is defined as the av- erage of the static gains for each snapshot of T ; 2. given a partition of the node set, the same transformation of Louvain is applied to every snapshot of T independently (with different weights for each snapshot) to obtain a new evolving network between the communities of the partition. The authors finally propose a method using sliding win- dows to segment the evolution of the network in stable periods, potentially hierarchically organized. B. Fixed memberships, evolving properties In (Gauvin et al., 2014), the authors propose to use a Non-Negative tensor factorization approach. First, all adjacency matrices, each corresponding to a network snapshot, are stacked together in a 3-way tensor (a 3-dimensional matrix with a dimension corresponding to time). A custom non-negative factorization method is applied, with the number of desired communities as input, that yields two matrices: one corresponds to the membership weight of nodes to components, and the other to the activity level of components for each time corresponding to a snapshot. It can be noted that each node can have a non-zero membership to several (often all) communities. A post-process step is introduced to discard memberships below a given threshold and, thus, simplify the results. In (Matias et al., 2015, 2018) the authors propose to use a Poisson Process Stochastic Block Model (PPSBM) to find clusters in temporal networks. As in a static SBM, nodes belong to groups, and each pair of groups is characterized by unique connection characteristics. Unlike static SBM, such connection characteristic is not defined by a single value, but by a function of time f (intensity of conditional inhomo- geneous Poisson process) representing the probability of observing interactions at each point in time. The authors propose an adapted Expectation-Maximization (EM) to find both the belonging of nodes and f that better fit the observed network. It is to be noted that nodes do not change their affiliation using this approach, but instead, it is the clusters' properties that evolve along time. 35 that determines the probability for nodes belonging to a cluster to move to each other cluster at each step. The optimal parameters of this model are searched for using a custom Expectation-Maximization (EM) algorithm. The βql are constant for the same community for all time steps. Two versions of the framework are discussed: • online learning which updates the probabilistic model iteratively (in this case, the method is a Tem- poral Trade-Off CD); • offline learning which learns the probabilistic model with network data obtained at all time steps (in this case, the method is a Cross-Time CD). Variations having a similar rationale have been proposed by different authors, most notably in (Herlau et al., 2013; Ishiguro et al., 2010). The version in (Xu and Hero, 2014) allows properties to evolve, see appropriate section. In (Matias and Miele, 2016), the authors propose to use a Dynamic Stochastic Block Model, similar to (Yang et al., 2009). As in a typical static SBM, nodes belong to clusters, and an interaction probability βql is assigned to each pair of clusters (q, l). The dynamic aspect is handled as an aperiodic stationary Markov chain, defined as a transition matrix π, characterizing the probability of a node belonging to a given cluster a at time t to belong to each one of the other clusters at time t + 1. The optimal parameters of this model are searched for using a custom Expectation-Maximization (EM) algorithm. The authors note that it is not possible to allow the variation of β and node memberships parameters at each step simultaneously, and therefore impose a single value for each intra-group connection parameter βqq along the whole evolution -- thus, search- ing for clusters with stable intra-groups interaction probabilities. Finally, authors introduce a method for automatically finding the best number of clusters using Integrated Classification Likelihood (ICL), and an initialization procedure allowing to converge to better local maximum using an adapted k-means algorithm. In (Ghasemian et al., 2016), the authors also use a Dynamic Stochastic Block Model similar to (Yang et al., 2009), and propose scalable algorithms to optimize the parameters of the model based on belief propagation and spectral clustering. They also study the detectability threshold of the community structure as a function of the rate of change and the strength of communities. C. Evolving memberships, fixed properties In (Yang et al., 2009, 2011), the authors propose to use a Dynamic Stochastic Block Model. As in a typical static SBM, nodes belong to clusters, and an interaction probability βql is assigned to each pair of clusters (q, l). The dynamic aspect is handled by a transition matrix, In (Jdidia et al., 2007), the authors propose to add edges between nodes in different snapshots, i.e. edges linking nodes at t and t + 1. Two types of these edges can be added: D. Evolving memberships, evolving properties • identity edges between the same node, if present at t and t + 1, and • transversal edges between different nodes in differ- ent snapshots. To do so, the following relation must hold: there is an edge between u ∈ t and v ∈ t + 1 if ∃w such that (u, w) ∈ t and (v, w) ∈ t + 1. A static CD algorithm, Walktrap, is consequently applied to this transversal network to obtain dynamic communities. The method introduced in (Mucha et al., 2010) has been designed for any multi-sliced network, in- cluding evolving networks. The main contribution lies in a multislice generalization of modularity that exploits laplacian dynamics. This method is equivalent to adding links between same nodes in different slices, and then run a community detection on the resulting graph. In the article, edges are added only between same nodes in adjacent slices. The weight of these edges is a parameter of the method. The authors underline 36 that the resolution of the modularity can vary from slice to slice. In (Bassett et al., 2013), variations of the same method using different null models are explored. In (Viard et al., 2016), the notion of clique is gen- eralized to link streams. A ∆-clique is a set of nodes and a time interval such that all nodes in this set are pairwise connected at least once during any sub-interval of duration ∆ of the interval. The paper presents an al- gorithm able to compute all maximal (in terms of nodes or time interval) ∆-cliques in a given link stream, for a given ∆. A solution able to reduce the computational complexity has been proposed in (Himmel et al., 2016). In (Xu and Hero, 2014), a dynamic SBM in intro- duced. Contrary to (Yang et al., 2009), it allows community properties (i.e., densities between pairs of nodes) to evolve. Note that a potential identifiability problem with allowing both membership and properties to evolve in dynamic SBM was later pointed out in (Matias and Miele, 2016).
1906.07159
2
1906
2019-09-17T05:09:09
vGraph: A Generative Model for Joint Community Detection and Node Representation Learning
[ "cs.SI", "cs.LG", "stat.ML" ]
This paper focuses on two fundamental tasks of graph analysis: community detection and node representation learning, which capture the global and local structures of graphs, respectively. In the current literature, these two tasks are usually independently studied while they are actually highly correlated. We propose a probabilistic generative model called vGraph to learn community membership and node representation collaboratively. Specifically, we assume that each node can be represented as a mixture of communities, and each community is defined as a multinomial distribution over nodes. Both the mixing coefficients and the community distribution are parameterized by the low-dimensional representations of the nodes and communities. We designed an effective variational inference algorithm which regularizes the community membership of neighboring nodes to be similar in the latent space. Experimental results on multiple real-world graphs show that vGraph is very effective in both community detection and node representation learning, outperforming many competitive baselines in both tasks. We show that the framework of vGraph is quite flexible and can be easily extended to detect hierarchical communities.
cs.SI
cs
VGRAPH: A GENERATIVE MODEL FOR JOINT COMMUNITY DETECTION AND NODE REPRESENTATION LEARNING A PREPRINT Fan-Yun Sun1,2, Meng Qu2, Jordan Hoffmann2,3, Chin-Wei Huang2,4, Jian Tang2,5,6 1National Taiwan University, 2Mila-Quebec Institute for Learning Algorithms, Canada 3Harvard University, USA 4Element AI, Canada 5HEC Montreal, Canada 6CIFAR AI Research Chair [email protected] ABSTRACT This paper focuses on two fundamental tasks of graph analysis: community detection and node representation learning, which capture the global and local structures of graphs, respectively. In the current literature, these two tasks are usually independently studied while they are actually highly correlated. We propose a probabilistic generative model called vGraph to learn community membership and node representation collaboratively. Specifically, we assume that each node can be represented as a mixture of communities, and each community is defined as a multinomial distribution over nodes. Both the mixing coefficients and the community distribution are parameterized by the low-dimensional representations of the nodes and communities. We designed an effective variational inference algorithm which regularizes the community membership of neighboring nodes to be similar in the latent space. Experimental results on multiple real-world graphs show that vGraph is very effective in both community detection and node representation learning, outperforming many competitive baselines in both tasks. We show that the framework of vGraph is quite flexible and can be easily extended to detect hierarchical communities. 1 Introduction Graphs, or networks, are a general and flexible data structure to encode complex relationships among objects. Examples of real-world graphs include social networks, airline networks, protein-protein interaction networks, and traffic networks. Recently, there has been increasing interest from both academic and industrial communities in analyzing graphical data. Examples span a variety of domains and applications such as node classification [3, 26] and link prediction [8, 32] in social networks, role prediction in protein-protein interaction networks [16], and prediction of information diffusion in social and citation networks [22]. One fundamental task of graph analysis is community detection, which aims to cluster nodes into multiple groups called communities. Each community is a set of nodes that are more closely connected to each other than to nodes in different communities. A community level description is able to capture important information about a graph's global structure. Such a description is useful in many real-world applications, such as identifying users with similar interests in social networks [22] or proteins with similar functionality in biochemical networks [16]. Community detection has been extensively studied in the literature, and a number of methods have been proposed, including algorithmic approaches [1, 5] and probabilistic models [10, 20, 36, 37]. A classical approach to detect communities is spectral clustering [34], which assumes that neighboring nodes tend to belong to the same communities and detects communities by finding the eigenvectors of the graph Laplacian. Another important task of graph analysis is node representation learning, where nodes are described using low- dimensional features. Node representations effectively capture local graph structure and are often used as features for vGraph: A Generative Model for Joint Community Detection and Node Representation Learning many prediction tasks. Modern methods for learning node embeddings [11, 24, 26] have proved effective on a variety of tasks such as node classification [3, 26], link prediction [8, 32] and graph visualization [27, 31]. Clustering, which captures the global structure of graphs, and learning node embeddings, which captures local structure, are typically studied separately. Clustering is often used for exploratory analysis, while generating node embeddings is often done for predictive analysis. However, these two tasks are very correlated and it may be beneficial to perform both tasks simultaneously. The intuition is that (1) node representations can be used as good features for community detection (e.g., through K-means) [4, 25, 29], and (2) the node community membership can provide good contexts for learning node representations [33]. However, how to leverage the relatedness of node clustering and node embedding in a unified framework for joint community detection and node representation learning is under-explored. In this paper, we propose a novel probabilistic generative model called vGraph for joint community detection and node representation learning. vGraph assumes that each node v can be represented as a mixture of multiple communities and is described by a multinomial distribution over communities z, i.e., p(zv). Meanwhile, each community z is modeled as a distribution over the nodes v, i.e., p(vz). vGraph models the process of generating the neighbors for each node. Given a node u, we first draw a community assignment z from p(zu). This indicates which community the node is going to interact with. Given the community assignment z, we generate an edge (u, v) by drawing another node v according to the community distribution p(vz). Both the distributions p(zv) and p(vz) are parameterized by the low-dimensional representations of the nodes and communities. As a result, this approach allows the node representations and the communities to interact in a mutually beneficial way. We also design a very effective algorithm for inference with backpropagation. We use variational inference for maximizing the lower-bound of the data likelihood. The Gumbel-Softmax [13] trick is leveraged since the community membership variables are discrete. Inspired by existing spectral clustering methods [6], we added a smoothness regularization term to the objective function of the variational inference routine to ensure that community membership of neighboring nodes is similar. The whole framework of vGraph is very flexible and general. We also show that it can be easily extended to detect hierarchical communities. In the experiment section, we show results on three tasks: overlapping community detection, non-overlapping community detection, and node classification -- all using various real-world datasets. Our results show that vGraph is very competitive with existing state-of-the-art approaches for these tasks. We also present results on hierarchical community detection. 2 Related Work Community Detection. Many community detection methods are based on matrix factorization techniques. Typically, these methods try to recover the node-community affiliation matrix by performing a low-rank decomposition of the graph adjacency matrix or other related matrices [17, 18, 32, 36]. These methods are not scalable due to the complexity of matrix factorization, and their performance is restricted by the capacity of the bi-linear models. Many other studies develop generative models for community detection. Their basic idea is to characterize the generation process of graphs and cast community detection as an inference problem [37, 38, 39]. However, the computational complexity of these methods is also high due to complicated inference. Compared with these approaches, vGraph is more scalable and can be efficiently optimized with backpropagation and Gumbel-Softmax [13, 19]. Additionally, vGraph is able to learn and leverage the node representations for community detection. Node Representation Learning. The goal of node representation learning is to learn distributed representations of nodes in graphs so that nodes with similar local connectivity tend to have similar representations. Some representative methods include DeepWalk [24], LINE [26], node2vec [11] and GraphRep [3]. Typically, these methods explore the local connectivity of each node by conducting random walks with either breadth-first search [24] or depth-first search [26]. Despite their effectiveness in a variety of applications, these methods mainly focus on preserving the local structure of graphs, therefore ignoring global community information. In vGraph, we address this limitation by treating the community label as a latent variable. This way, the community label can provide additional contextual information which enables the learned node representations to capture the global community information. Framework for node representation learning and community detection. There exists previous work [4, 14, 29, 30, 33] that attempts to solve community detection and node representation learning jointly. However, their optimization process alternates between community assignment and node representation learning instead of simultaneously solving both tasks [4, 30]. Compared with these methods, vGraph is scalable and the optimization is done end-to-end. Mixture Models. Methodologically, our method is related to mixture models, particularly topic models (e.g. PSLA [12] and LDA [2]). These methods simulate the generation of words in documents, in which topics are treated as latent variables, whereas we consider generating neighbors for each node in a graph, and the community acts as a latent 2 vGraph: A Generative Model for Joint Community Detection and Node Representation Learning (a) vGraph (b) Hierarchical vGraph Figure 1: The diagram on the left represents the graphical model of vGraph and the diagram on the right represents the graphical model of the hierarchical extension. φn is the embedding of node wn, ψ denotes the embedding of communities, and ϕ denotes the embeddings of nodes used in p(cz). Refer to Eq. 2 and Eq. 3. variable. Compared with these methods, vGraph parameterizes the distributions with node and community embeddings, and all the parameters are trained with backpropagation. 3 Problem Definition Graphs are ubiquitous in the real-world. Two fundamental tasks on graphs are community detection and learning node embeddings, which focus on global and local graph structures respectively and hence are naturally complementary. In this paper, we study jointly solving these two tasks. Let G = (V,E) represent a graph, where V = {v1, . . . , vV } is a set of vertices and E = {eij} is the set of edges. Traditional graph embedding aims to learn a node embedding φi ∈ Rd for each vi ∈ V where d is predetermined. Community detection aims to extract the community membership F for each node. Suppose there are K communities on the graph G, we can denote the community assignment of node vi as F(vi) ⊆ {1, ..., K}. We aim to jointly learn node embeddings φ and community affiliation of vertices F. 4 Methodology In this section, we introduce our generative approach vGraph, which aims at collaboratively learning node representations and detecting node communities. Our approach assumes that each node can belong to multiple communities representing different social contexts [7]. Each node should generate different neighbors under different social contexts. vGraph parameterizes the node-community distributions by introducing node and community embeddings. In this way, the node representations can benefit from the detection of node communities. Similarly, the detected community assignment can in turn improve the node representations. Inspired by existing spectral clustering methods [6], we add a smoothness regularization term that encourages linked nodes to be in the same communities. 4.1 vGraph vGraph models the generation of node neighbors. It assumes that each node can belong to multiple communities. For each node, different neighbors will be generated depending on the community context. Based on the above intuition, we introduce a prior distribution p(zw) for each node w and a node distribution p(cz) for each community z. The generative process of each edge (w, c) can be naturally characterized as follows: for node w, we first draw a community assignment z ∼ p(zw), representing the social context of w during the generation process. Then, the linked neighbor c is generated based on the assignment z through c ∼ p(cz). Formally, this generation process can be formulated in a probabilistic way: (cid:88) p(cw) = p(cz)p(zw). vGraph parameterizes the distributions p(zw) and p(cz) by introducing a set of node embeddings and community embeddings. Note that different sets of node embeddings are used to parametrize the two distributions. Specifically, let φi denote the embedding of node i used in the distribution p(zw), ϕi denote the embedding of node i used in z 3 (1) vGraph: A Generative Model for Joint Community Detection and Node Representation Learning p(cz), and ψj denote the embedding of the j-th community. The prior distribution pφ,ψ(zw) and the node distribution conditioned on a community pψ,ϕ(cz) are parameterized by two softmax models: pφ,ψ(z = jw) = pψ,ϕ(cz = j) = (cid:80)K (cid:80) c exp(φT wψj) i=1 exp(φT wψi) , exp(ψT j ϕc) (cid:48)∈V exp(ψT j ϕc . (cid:48) ) (2) (3) Calculating Eq. 3 can be expensive as it requires summation over all vertices. Thus, for large datasets we can employ negative sampling as done in LINE [26] using the following objective function: log σ(ϕT c · ψj) + Ev∼Pn(v)[log σ(−ϕT v · ψj)], (4) K(cid:88) i=1 where σ(x) = 1/(1 + exp(−x)), Pn(v) is a noise distribution, and K is the number of negative samples. This, combined with stochastic optimization, enables our model to be scalable. To learn the parameters of vGraph, we try to maximize the log-likelihood of the observed edges, i.e., log pφ,ϕ,ψ(cw). Since directly optimizing this objective is intractable for large graphs, we instead optimize the following evidence lower bound (ELBO) [15]: L = Ez∼q(zc,w)[log pψ,ϕ(cz)] − KL(q(zc, w)pφ,ψ(zw)) (5) where q(zc, w) is a variational distribution that approximates the true posterior distribution p(zc, w), and KL(··) represents the Kullback-Leibler divergence between two distributions. Specifically, we parametrize the variational distribution q(zc, w) with a neural network as follows: (cid:80)K exp((φw (cid:12) φc)T ψj) i=1 exp((φw (cid:12) φc)T ψi) qφ,ψ(z = jw, c) = (6) where (cid:12) denotes element-wise multiplication. We chose element-wise multiplication because it is symmetric and it forces the representation of the edge to be dependent on both nodes. The variational distribution q(zc, w) represents the community membership of the edge (w, c). Based on this, we can easily approximate the community membership distribution of each node w, i.e., p(zw) by aggregating all its neighbors: . p(zw) = p(z, cw) = p(zw, c)p(cw) ≈ q(zw, c), (7) (cid:88) (cid:88) c c (cid:88) c∈N (w) 1 N (w) where N (w) is the set of neighbors of node w. To infer non-overlapping communities, we can simply take the arg max of p(zw). However, when detecting overlapping communities instead of thresholding p(zw) as in [14], we use F(w) = {arg max k q(z = kw, c)}c∈N (w). (8) That is, we assign each edge to one community and then map the edge communities to node communities by gathering nodes incident to all edges within each edge community as in [1]. Complexity. Here we show the complexity of vGraph. Sampling an edge takes constant time, thus calculating Eq. (4) takes O(d(M + 1)) time, where M is the number of negative samples and d is the dimension of embeddings (the node embeddings and community embeddings have the same dimension). To calculate Eq. (6), it takes O(dK) time where K is the number of communities. Thus, an iteration with one sample takes O(max(dM, dK)) time. In practice the number of updates required is proportional to the number of edges O(E), thus the overall time complexity of vGraph is O(Ed max(M, K)). 4.2 Community-smoothness Regularized Optimization For optimization, we need to optimize the lower bound (5) w.r.t. the parameters in the variational distribution and the generative parameters. If z is continuous, the reparameterization trick [15] can be used. However, z is discrete in our case. In principle, we can still estimate the gradient using a score function estimator [9, 35]. However, the 4 vGraph: A Generative Model for Joint Community Detection and Node Representation Learning score function estimator suffers from a high variance, even when used with a control variate. Thus, we use the Gumbel-Softmax reparametrization [13, 19] to obtain gradients for the evidence lower bound. More specifically, we use the straight-through Gumbel-Softmax estimator [13]. A community can be defined as a group of nodes that are more similar to each other than to those outside the group [23]. For a non-attributed graph, two nodes are similar if they are connected and share similar neighbors. However, vGraph does not explicitly weight local connectivity in this way. To resolve this, inspired by existing spectral clustering studies [6], we augment our training objective with a smoothness regularization term that encourages the learned community distributions of linked nodes to be similar. Formally, the regularization term is given below: Lreg = λ αw,c · d(p(zc), p(zw)) (9) (cid:88) (w,c)∈E where λ is a tunable hyperparameter , αw,c is a regularization weight, and d(·,·) is the distance between two distributions (squared difference in our experiments). Motivated by [25], we set αw,c to be the Jaccard's coefficient of node w and c, which is given by: αw,c = N (w) ∩ N (c) N (w) ∪ N (c) , (10) (cid:88) where N (w) denotes the set of neighbors of w. The intuition behind this is that αw,c serves as a similarity measure of how similar the neighbors are between two nodes. Jaccard's coefficient is used for this metric and thus the higher the value of Jaccard's coefficient, the more the two nodes are encouraged to have similar distribution over communities. By combining the evidence lower bound and the smoothness regularization term, the entire loss function we aim to minimize is given below: L = −Ez∼qφ,ψ(zc,w)[log pψ,ϕ(cz)] + KL(qφ,ψ(zc, w)pφ,ψ(zw)) + Lreg (11) For large datasets, negative sampling can be used for the first term. 4.3 Hierarchical vGraph One advantage of vGraph's framework is that it is very general and can be naturally extended to detect hierarchical communities. In this case, suppose we are given a d-level tree and each node is associate with a community, the community assignment can be represented as a d-dimensional path vector (cid:126)z = (z(1), z(2), ..., z(d)), as shown in Fig. 1. Then, the generation process is formulated as below: (1) a tree path (cid:126)z is sampled from a prior distribution pφ,ψ((cid:126)zw). (2) The context c is decoded from (cid:126)z with pψ,ϕ(c(cid:126)z). Under this model, the likelihood of the network is pφ,ϕ,ψ(cw) = pφ,ψ(c(cid:126)z)pφ,ψ((cid:126)zw). (12) At every node of the tree, there is an embedding vector associated with the community. Such a method is similar to the hierarchical softmax parameterization used in language models [21]. (cid:126)z 5 Experiments As vGraph can detect both overlapping and non-overlapping communities, we evaluate it on three tasks: overlapping community detection, non-overlapping community detection, and vertex classification. 5.1 Datasets We evaluate vGraph on 20 standard graph datasets. For non-overlapping community detection and node classification, we use 6 datasets: Citeseer, Cora, Cornell, Texas, Washington, and Wisconsin. For overlapping communtiy detection, we use 14 datasets, including Facebook, Youtube, Amazon, Dblp, Coauthor-CS. For Youtube, Amazon, and Dblp, we consider subgraphs with the 5 largest ground-truth communities due to the runtime of baseline methods. To demonstrate the scalability of our method, we additionally include visualization results on a large dataset -- Dblp-full. Dataset statistics are provided in Table 1. More details about the datasets is provided in Appendix A. 5.2 Evaluation Metric 5 vGraph: A Generative Model for Joint Community Detection and Node Representation Learning Table 2: Evaluation (in terms of F1-Score and Jaccard Similarity) on networks with overlapping ground-truth communi- ties. NA means the task is not completed in 24 hours. In order to evaluate the effectiveness of smoothness regularization, we show the result of our model with (vGraph+) and without the regularization. Dataset facebook0 facebook107 facebook1684 facebook1912 facebook3437 facebook348 facebook3980 facebook414 facebook686 facebook698 Youtube Amazon Dblp Coauthor-CS F1-score Bigclam CESNA Circles 0.2948 0.2860 0.3928 0.2467 0.2894 0.5041 0.2617 0.3493 0.1009 0.1986 0.5175 0.4964 0.3203 0.3274 0.5886 0.4843 0.5036 0.3825 0.3515 0.5423 0.3600 0.4370 0.5330 0.4640 0.2360 0.3830 0.2806 0.3733 0.5121 0.3474 0.2009 0.5375 0.3574 0.6007 0.3900 0.5865 0.3840 0.4680 0.3590 0.4200 NA NA SVI 0.2810 0.2689 0.3591 0.2804 0.1544 0.4607 NA 0.3893 0.4639 0.4031 0.4140 0.4730 NA 0.4070 vGraph 0.2440 0.2817 0.4232 0.2579 0.2087 0.5539 0.4450 0.6471 0.4775 0.5396 0.5070 0.5330 0.3930 0.4980 vGraph+ 0.2606 0.3178 0.4379 0.3750 0.2267 0.5314 0.4150 0.6693 0.5379 0.5950 0.5220 0.5320 0.3990 0.5020 Jaccard Bigclam CESNA Circles 0.1846 0.1862 0.2752 0.1547 0.1871 0.3801 0.1672 0.2412 0.0545 0.1148 0.3927 0.3586 0.2097 0.2426 0.4713 0.3418 0.3615 0.2504 0.2255 0.4192 0.2207 0.2929 0.3505 0.3671 0.1384 0.2409 0.1725 0.2695 0.3871 0.2394 0.1165 0.4001 0.2645 0.4732 0.2534 0.4588 0.2416 0.3502 0.2226 0.2682 NA NA SVI 0.1760 0.1719 0.2467 0.2010 0.0902 0.3360 NA 0.2931 0.3394 0.3002 0.2867 0.3643 NA 0.2972 vGraph 0.1458 0.1827 0.2917 0.1855 0.1201 0.4099 0.3376 0.5184 0.3272 0.4356 0.3434 0.3689 0.2501 0.3517 vGraph+ 0.1594 0.2170 0.3272 0.2796 0.1328 0.4050 0.2933 0.5587 0.3856 0.4771 0.3480 0.3693 0.2505 0.3432 For overlapping community detection, we use F1-Score and Jaccard Similarity to measure the performance of the detected communities as in [37, 18]. For non-overlapping community detection, we use Nor- malized Mutual Information (NMI) [28] and Modularity. Note that Modularity does not utilize ground truth data. For node classification, Micro-F1 and Macro-F1 are used. 5.3 Comparative Methods V: number of Table 1: Dataset Statistics. nodes, E: number of edges, K: number of communities, AS: average size of communities, AN: average number of communities that a node belongs to. V 195 187 230 265 2708 3312 E 286 298 417 479 5278 4660 K 5 5 5 5 7 6 AS AN 39.00 37.40 46.00 53.00 386.86 552.00 1 1 1 1 1 1 Dataset Nonoverlapping Cornell Texas Washington Wisconsin Cora Citeseer overlapping facebook0 facebook107 facebook1684 facebook1912 facebook3437 facebook348 facebook3980 facebook414 facebook686 facebook698 Youtube Amazon Dblp Coauthor-CS Dblp-full For overlapping community detection, we choose four competitive baselines: BigCLAM [36], a nonnegative matrix factorization ap- proach based on the Bernoulli-Poisson link that only considers the graph structure; CESNA [37], an extension of BigCLAM, that ad- ditionally models the generative process for node attributes; Circles [20], a generative model of edges w.r.t. attribute similarity to de- tect communities; and SVI [10], a Bayesian model for graphs with overlapping communities that uses a mixed-membership stochastic blockmodel. To evaluate node embedding and non-overlapping community detec- tion, we compare our method with the five baselines: MF [32], which represents each vertex with a low-dimensional vector obtained through factoring the adjacency matrix; DeepWalk [24], a method that adopts truncated random walk and Skip-Gram to learn vertex embeddings; LINE [26], which aims to preserve the first-order and second-order proximity among vertices in the graph; Node2vec [11], which adopts biased random walk and Skip-Gram to learn vertex embeddings; and ComE [4], which uses a Gaussian mixture model to learn an embedding and clustering jointly using random walk features. 2519 26749 14024 30025 4813 3192 146 1693 1656 270 24121 2109 89063 33261 335520 333 1034 786 747 534 224 52 150 168 61 5346 794 24493 9252 93432 0.98 0.48 0.99 1.43 0.36 2.53 1.12 1.19 2.89 1.39 1.26 1.75 1.05 1.58 1.20 13.54 55.67 45.71 23.15 6.00 40.50 3.41 25.43 34.64 6.54 1347.80 277.20 5161.40 2920.60 22.45 24 9 17 46 32 14 17 7 14 13 5 5 5 5 5000 5.4 Experiment Configuration For all baseline methods, we use the implementations provided by their authors and use the default parameters. For methods that only output representations of vertices, we apply K-means to the learned embeddings to get non- overlapping communities. Results report are averaged over 5 runs. No node attributes are used in all our experiments. We generate node attributes using node degree features for those methods that require node attributes such as CESNA [37] and Circles [20]. It is hard to compare the quality of community results when the numbers of communities are different for different methods. Therefore, we set the number of communities to be detected, K, as the number of ground-truth communities for all methods, as in [18]. For vGraph, we use full-batch training when the dataset is small enough. Otherwise, we use stochastic training with a batch size of 5000 or 10000 edges. The initial learning rate is set to 0.05 and is decayed by 0.99 after every 100 iterations. We use the Adam optimizer and we trained for 5000 iterations. When smoothness regularization is used, λ is set to 100. For community detection, the model with the lowest loss is chosen. For node classification, we evaluate node embeddings after 1000 iterations of training. The dimension of node embeddings is set to 128 in all experiments for all methods. For the node classification task, we randomly select 70% of the labels for training and use the rest for testing. 6 vGraph: A Generative Model for Joint Community Detection and Node Representation Learning Table 3: Evaluation (in terms of NMI and Modularity) on networks with non-overlapping ground-truth communities. Dataset cornell texas washington wisconsin cora citeseer MF 0.0632 0.0562 0.0599 0.0530 0.2673 0.0552 deepwalk 0.0789 0.0684 0.0752 0.0759 0.3387 0.1190 NMI LINE 0.0697 0.1289 0.0910 0.0680 0.2202 0.0340 node2vec ComE 0.0732 0.0712 0.0772 0.0655 0.0504 0.0538 0.0689 0.0749 0.3660 0.3157 0.2499 0.1592 vGraph 0.0803 0.0809 0.0649 0.0852 0.3445 0.1030 MF 0.4220 0.2835 0.3679 0.3892 0.6711 0.6963 deepwalk 0.4055 0.3443 0.1841 0.3384 0.6398 0.6819 Modularity LINE 0.2372 0.1921 0.1655 0.1651 0.4832 0.4014 node2vec ComE 0.5748 0.4573 0.4856 0.3926 0.4862 0.4311 0.5500 0.5338 0.5392 0.7010 0.7324 0.4657 vGraph 0.5792 0.4636 0.5169 0.5706 0.7358 0.7711 Table 4: Results of node classification on 6 datasets. Macro-F1 Micro-F1 Datasets Cornell Texas Washington Wisconsin Cora Citeseer MF 13.05 8.74 15.88 14.77 11.29 14.59 DeepWalk LINE Node2Vec ComE vGraph 29.76 26.00 30.36 29.91 16.23 17.88 19.86 15.46 15.80 14.63 12.88 12.88 20.70 14.95 21.23 18.47 10.52 16.68 21.78 16.33 13.99 19.06 11.86 15.99 22.69 21.32 18.45 23.44 13.21 16.17 MF 15.25 14.03 15.94 18.75 12.79 15.79 DeepWalk LINE Node2Vec ComE vGraph 37.29 47.37 34.78 35.00 24.35 20.42 25.42 33.33 33.33 32.50 28.04 19.42 23.73 27.19 25.36 28.12 14.59 16.80 33.05 40.35 34.06 38.75 22.32 19.01 24.58 25.44 28.99 25.00 27.74 20.82 5.5 Results Table 2 shows the results on overlapping community detection. Some of the methods are not very scalable and cannot obtain results in 24 hours on some larger datasets. Compared with these studies, vGraph outperforms all baseline methods in 11 out of 14 datasets in terms of F1-score or Jaccard Similarity, as it is able to leverage useful representations at node level. Moreover, vGraph is also very efficient on these datasets, since we use employ variational inference and parameterize the model with node and community embeddings. By adding the smoothness regularization term (vGraph+), we see a farther increase performance, which shows that our method can be combined with concepts from traditional community detection methods. The results for non-overlapping community detection are presented in Table 3. vGraph outperforms all conventional node embeddings + K-Means in 4 out of 6 datasets in terms of NMI and outperforms all 6 in terms of modularity. ComE, another framework that jointly solves node embedding and community detection, also generally performs better than other node embedding methods + K-Means. This supports our claim that learning these two tasks collaboratively instead of sequentially can further enhance performance. Compare to ComE, vGraph performs better in 4 out of 6 datasets in terms of NMI and 5 out of 6 datasets in terms of modularity. This shows that vGraph can also outperform frameworks that learn node representations and communities together. Table 4 shows the result for the node classification task. vGraph significantly outperforms all the baseline methods in 9 out of 12 datasets. The reason is that most baseline methods only consider the local graph information without modeling the global semantics. vGraph solves this problem by representing node embeddings as a mixture of communities to incorporate global context. 5.6 Visualization In order to gain more insight, we present visualizations of the facebook107 dataset in Fig. 2(a). To demonstrate that our model can be applied to large networks, we present results of vGraph on a co-authorship network with around 100,000 nodes and 330,000 edges in Fig. 2(b). More visualizations are available in appendix B. We can observe that the community structure, or "social context", is reflected in the corresponding node embedding (node positions in both visualizations are determined by t-SNE of the node embeddings). To demonstrate the hierarchical extension of our model, we visualize a subset of the co-authorship dataset in Fig. 3. We visualize the first-tier communities and second-tier communities in panel (a) and (b) respectively. We can observe that the second-tier communities grouped under the same first-tier communities interact more with themselves than they do with other second-tier communities. 6 Conclusion In this paper, we proposed vGraph, a method that performs overlapping (and non-overlapping) community detection and learns node and community embeddings at the same time. vGraph casts the generation of edges in a graph as an inference problem. To encourage collaborations between community detection and node representation learning, we assume that each node can be represented by a mixture of communities, and each community is defined as a multinomial distribution over nodes. We also design a smoothness regularizer in the latent space to encourage neighboring nodes to be similar. Empirical evaluation on 20 different benchmark datasets demonstrates the effectiveness of the proposed 7 vGraph: A Generative Model for Joint Community Detection and Node Representation Learning (a) (b) Figure 2: In panel (a) we visualize the result on the facebook107 dataset using vGraph. In panel (b) we visualize the result on Dblp-full dataset using vGraph. The coordinates of the nodes are determined by t-SNE of the node embeddings. (a) (b) (c) Figure 3: We visualize the result on a subset of Dblp dataset using two-level hierarchical vGraph. The coordinates of the nodes are determined by t-SNE of the node embeddings. In panel (a) we visualize the first-tier communities. In panel (b), we visualize the second-tier communities. In panel (c) we show the corresponding hierarchical tree structure. method on both tasks compared to competitive baselines. Furthermore, our model is also readily extendable to detect hierarchical communities. References [1] Yong-Yeol Ahn, James P Bagrow, and Sune Lehmann. Link communities reveal multiscale complexity in networks. nature, 466(7307):761, 2010. [2] David M Blei, Andrew Y Ng, and Michael I Jordan. Latent dirichlet allocation. Journal of machine Learning research, 3(Jan):993 -- 1022, 2003. [3] Shaosheng Cao, Wei Lu, and Qiongkai Xu. Grarep: Learning graph representations with global structural In Proceedings of the 24th ACM international on conference on information and knowledge information. management, pages 891 -- 900. ACM, 2015. [4] Sandro Cavallari, Vincent W Zheng, Hongyun Cai, Kevin Chen-Chuan Chang, and Erik Cambria. Learning community embedding with community detection and node embedding on graphs. In Proceedings of the 2017 ACM on Conference on Information and Knowledge Management, pages 377 -- 386. ACM, 2017. [5] Imre Derényi, Gergely Palla, and Tamás Vicsek. Clique percolation in random networks. Physical review letters, 94(16):160202, 2005. [6] Xiaowen Dong, Pascal Frossard, Pierre Vandergheynst, and Nikolai Nefedov. Clustering with multi-layer graphs: A spectral perspective. IEEE Transactions on Signal Processing, 60(11):5820 -- 5831, 2012. [7] Alessandro Epasto and Bryan Perozzi. Is a single embedding enough? learning node representations that capture multiple social contexts. 2019. 8 vGraph: A Generative Model for Joint Community Detection and Node Representation Learning [8] Sheng Gao, Ludovic Denoyer, and Patrick Gallinari. Temporal link prediction by integrating content and structure information. In Proceedings of the 20th ACM international conference on Information and knowledge management, pages 1169 -- 1174. ACM, 2011. [9] Peter W Glynn. Likelihood ratio gradient estimation for stochastic systems. Communications of the ACM, 33(10):75 -- 84, 1990. [10] Prem K Gopalan and David M Blei. Efficient discovery of overlapping communities in massive networks. Proceedings of the National Academy of Sciences, 110(36):14534 -- 14539, 2013. [11] Aditya Grover and Jure Leskovec. node2vec: Scalable feature learning for networks. In Proceedings of the 22nd ACM SIGKDD international conference on Knowledge discovery and data mining, pages 855 -- 864. ACM, 2016. [12] Thomas Hofmann. Probabilistic latent semantic analysis. In Proceedings of the Fifteenth conference on Uncertainty in artificial intelligence, pages 289 -- 296. Morgan Kaufmann Publishers Inc., 1999. [13] Eric Jang, Shixiang Gu, and Ben Poole. Categorical reparameterization with gumbel-softmax. arXiv preprint arXiv:1611.01144, 2016. [14] Yuting Jia, Qinqin Zhang, Weinan Zhang, and Xinbing Wang. Communitygan: Community detection with generative adversarial nets. arXiv preprint arXiv:1901.06631, 2019. [15] Diederik P Kingma and Max Welling. Auto-encoding variational bayes. arXiv preprint arXiv:1312.6114, 2013. [16] Nevan J Krogan, Gerard Cagney, Haiyuan Yu, Gouqing Zhong, Xinghua Guo, Alexandr Ignatchenko, Joyce Li, Shuye Pu, Nira Datta, Aaron P Tikuisis, et al. Global landscape of protein complexes in the yeast saccharomyces cerevisiae. Nature, 440(7084):637, 2006. [17] Da Kuang, Chris Ding, and Haesun Park. Symmetric nonnegative matrix factorization for graph clustering. In Proceedings of the 2012 SIAM international conference on data mining, pages 106 -- 117. SIAM, 2012. [18] Ye Li, Chaofeng Sha, Xin Huang, and Yanchun Zhang. Community detection in attributed graphs: an embedding approach. In Thirty-Second AAAI Conference on Artificial Intelligence, 2018. [19] Chris J Maddison, Andriy Mnih, and Yee Whye Teh. The concrete distribution: A continuous relaxation of discrete random variables. arXiv preprint arXiv:1611.00712, 2016. [20] Julian McAuley and Jure Leskovec. Discovering social circles in ego networks. ACM Transactions on Knowledge Discovery from Data (TKDD), 8(1):4, 2014. [21] Frederic Morin and Yoshua Bengio. Hierarchical probabilistic neural network language model. volume 5, pages 246 -- 252. Citeseer, 2005. In Aistats, [22] Mark EJ Newman and Michelle Girvan. Finding and evaluating community structure in networks. Physical review E, 69(2):026113, 2004. [23] Yulong Pei, Nilanjan Chakraborty, and Katia Sycara. Nonnegative matrix tri-factorization with graph regularization In Twenty-Fourth International Joint Conference on Artificial for community detection in social networks. Intelligence, 2015. [24] Bryan Perozzi, Rami Al-Rfou, and Steven Skiena. Deepwalk: Online learning of social representations. In Proceedings of the 20th ACM SIGKDD international conference on Knowledge discovery and data mining, pages 701 -- 710. ACM, 2014. [25] Benedek Rozemberczki, Ryan Davies, Rik Sarkar, and Charles Sutton. Gemsec: graph embedding with self clustering. arXiv preprint arXiv:1802.03997, 2018. [26] Jian Tang, Meng Qu, Mingzhe Wang, Ming Zhang, Jun Yan, and Qiaozhu Mei. Line: Large-scale information network embedding. In Proceedings of the 24th international conference on world wide web, pages 1067 -- 1077. International World Wide Web Conferences Steering Committee, 2015. [27] Jiliang Tang, Charu Aggarwal, and Huan Liu. Node classification in signed social networks. In Proceedings of the 2016 SIAM International Conference on Data Mining, pages 54 -- 62. SIAM, 2016. [28] Fei Tian, Bin Gao, Qing Cui, Enhong Chen, and Tie-Yan Liu. Learning deep representations for graph clustering. In Twenty-Eighth AAAI Conference on Artificial Intelligence, 2014. [29] Anton Tsitsulin, Davide Mottin, Panagiotis Karras, and Emmanuel Müller. Verse: Versatile graph embeddings from similarity measures. In Proceedings of the 2018 World Wide Web Conference on World Wide Web, pages 539 -- 548. International World Wide Web Conferences Steering Committee, 2018. [30] Cunchao Tu, Xiangkai Zeng, Hao Wang, Zhengyan Zhang, Zhiyuan Liu, Maosong Sun, Bo Zhang, and Leyu Lin. A unified framework for community detection and network representation learning. IEEE Transactions on Knowledge and Data Engineering, 2018. 9 vGraph: A Generative Model for Joint Community Detection and Node Representation Learning [31] Daixin Wang, Peng Cui, and Wenwu Zhu. Structural deep network embedding. In Proceedings of the 22nd ACM SIGKDD international conference on Knowledge discovery and data mining, pages 1225 -- 1234. ACM, 2016. [32] Fei Wang, Tao Li, Xin Wang, Shenghuo Zhu, and Chris Ding. Community discovery using nonnegative matrix factorization. Data Mining and Knowledge Discovery, 22(3):493 -- 521, 2011. [33] Xiao Wang, Peng Cui, Jing Wang, Jian Pei, Wenwu Zhu, and Shiqiang Yang. Community preserving network embedding. In Thirty-First AAAI Conference on Artificial Intelligence, 2017. [34] Scott White and Padhraic Smyth. A spectral clustering approach to finding communities in graphs. In Proceedings of the 2005 SIAM international conference on data mining, pages 274 -- 285. SIAM, 2005. [35] Ronald J Williams. Simple statistical gradient-following algorithms for connectionist reinforcement learning. Machine learning, 8(3-4):229 -- 256, 1992. [36] Jaewon Yang and Jure Leskovec. Overlapping community detection at scale: a nonnegative matrix factorization approach. In Proceedings of the sixth ACM international conference on Web search and data mining, pages 587 -- 596. ACM, 2013. [37] Jaewon Yang, Julian McAuley, and Jure Leskovec. Community detection in networks with node attributes. In 2013 IEEE 13th International Conference on Data Mining, pages 1151 -- 1156. IEEE, 2013. [38] Hongyi Zhang, Irwin King, and Michael R Lyu. Incorporating implicit link preference into overlapping community detection. In Twenty-Ninth AAAI Conference on Artificial Intelligence, 2015. [39] Mingyuan Zhou. Infinite edge partition models for overlapping community detection and link prediction. In Artificial Intelligence and Statistics, pages 1135 -- 1143, 2015. 10 vGraph: A Generative Model for Joint Community Detection and Node Representation Learning A Datasets Citeseer, Cora, Cornell, Texas, Washington, and Wisconsin are available online1. For Youtube, Amazon, and Dblp, we consider subgraphs with the 5 largest ground-truth communities due to the runtime of the baseline methods. Facebook2 is a set of Facebook ego-networks. It contains 10 different ego-networks with identified circles. Social circles formed by friends are regarded as ground-truth communities. Youtube3 is a network of social relationships of Youtube users. The vertices represent users; the edges indicate friendships among the users; the user-defined groups are considered as ground-truth communities. Amazon4 is collected by crawling amazon website. The vertices represent products and the edges indicate products frequently purchased together. The ground-truth communities are defined by the product categories on Amazon. Dblp5 is a co-authorship network from Dblp. The vertices represent researchers and the edges indicate co-author relationships. Authors who have published in a same journal or conference form a community. Coauthor-CS6 is a computer science co-authorship network. We chose 21 conferences and group them into five categories: Machine Learning, Computer Linguistics, Programming language, Data mining, and Database. 1https://linqs.soe.ucsc.edu 2https://snap.stanfod.edu/data/ego-Facebook.html 3http://snap.stanford.edu/data/com-Youtube.html 4http://snap.stanford.edu/data/com-Amazon.html 5http://snap.stanford.edu/data/com-DBLP.html 6https://aminer.org/aminernetwork 11 vGraph: A Generative Model for Joint Community Detection and Node Representation Learning B Visualization Figure 4: Visualization of the result of vGraph on the facebook1684 dataset. The coordinates of the nodes are determined by t-SNE of the node embeddings. 12 vGraph: A Generative Model for Joint Community Detection and Node Representation Learning Figure 5: Visualization of the result of vGraph on the facebook107 dataset. The coordinates of the nodes are determined by t-SNE of the node embeddings. Figure 6: Visualization of the result of vGraph on the facebook414 dataset. The coordinates of the nodes are determined by t-SNE of the node embeddings. 13 vGraph: A Generative Model for Joint Community Detection and Node Representation Learning Figure 7: Visualization of the result of vGraph on the Youtube dataset. The coordinates of the nodes are determined by t-SNE of the node embeddings. 14
1907.10453
1
1907
2019-07-24T13:58:07
Detecting Stable Communities in Link Streams at Multiple Temporal Scales
[ "cs.SI", "physics.soc-ph" ]
Link streams model interactions over time in a wide range of fields. Under this model, the challenge is to mine efficiently both temporal and topological structures. Community detection and change point detection are one of the most powerful tools to analyze such evolving interactions. In this paper, we build on both to detect stable community structures by identifying change points within meaningful communities. Unlike existing dynamic community detection algorithms, the proposed method is able to discover stable communities efficiently at multiple temporal scales. We test the effectiveness of our method on synthetic networks, and on high-resolution time-varying networks of contacts drawn from real social networks.
cs.SI
cs
Detecting Stable Communities in Link Streams at Multiple Temporal Scales∗ Souaad Boudebza1, R´emy Cazabet2, Omar Nouali3, and Fai¸cal Azouaou1 1 Ecole nationale Sup´erieure d'Informatique, BP 68M, 16309, Oued-Smar, Alger, 2 Univ Lyon, Universite Lyon 1, CNRS, LIRIS UMR5205, F-69622 France 3 Division de Recherche en Th´eorie et Ing´enierie des Syst`emes Informatiques,CERIST, Rue des Fr`eres Aissiou, Ben Aknoun, Alger, Algeria Algeria Abstract. Link streams model interactions over time in a wide range of fields. Under this model, the challenge is to mine efficiently both tempo- ral and topological structures. Community detection and change point detection are one of the most powerful tools to analyze such evolving interactions. In this paper, we build on both to detect stable community structures by identifying change points within meaningful communities. Unlike existing dynamic community detection algorithms, the proposed method is able to discover stable communities efficiently at multiple tem- poral scales. We test the effectiveness of our method on synthetic net- works, and on high-resolution time-varying networks of contacts drawn from real social networks. 1 Introduction In recent years, studying interactions over time has witnessed a growing interest in a wide range of fields, such as sociology, biology, physics, etc. Such dynamic interactions are often represented using the snapshot model: the network is di- vided into a sequence of static networks, i.e., snapshots, aggregating all contacts occurring in a given time window. The main drawback of this model is that it often requires to choose arbitrarily a temporal scale of analysis. The link stream model [9] is a more effective way for representing interactions over time, that can fully capture the underling temporal information. Real world networks evolve frequently at many different time scales. Fluc- tuations in such networks can be observed at yearly, monthly, daily, hourly, or even smaller scales. For instance, if one were to look at interactions among work- ers in a company or laboratory, one could expect to discover clusters of people corresponding to meetings and/or coffee breaks, interacting at high frequency (e.g., every few seconds) for short periods (e.g., few minutes), project members interacting at medium frequency (e.g., once a day) for medium periods (e.g., ∗This work was supported by the ACADEMICS grant of the IDEXLYON, project of the Universite de Lyon, PIA operated by ANR-16-IDEX-0005, and of the project ANR-18-CE23-0004 of the French National Research Agency (ANR). 2 S. Boudebza et al. a few months), coordination groups interacting at low frequency (e.g., once a month) for longer periods (e.g., a few years), etc. An analysis of communities found at an arbitrary chosen scale would neces- sarily miss some of these communities: low latency ones are invisible using short aggregation windows, while high frequency ones are lost in the noise for long aggregation windows. A multiple temporal scale analysis of communities seems therefore the right solution to study networks of interactions represented as link streams. To the best of our knowledge, no such method exists in the literature. In this article, we propose a method having roots both in the literature on change point detection and in dynamic community detection. It detects what we call stable communities, i.e., groups of nodes forming a coherent community throughout a period of time, at a given temporal scale. The remainder of this paper is organized as follows. In Section 2, we present a brief review of related works. Then, we describe the proposed framework in detail in section 3. We experimentally evaluate the proposed method on both synthetic and real-world networks in section 4. 2 Related Work Our contribution relates to two active body of research: i) dynamic community detection and ii) change point detection. The aim of the former is to discover groups of nodes that persist over time, while the objective of the latter is to detect changes in the overall structure of a dynamic network. In this section, we present existing work in both categories, and how our proposed method relates to them. 2.1 Dynamic Community Detection The problem of detecting communities in dynamic networks has attracted a lot of attention in recent years, with various approaches tackling different aspects of the problem, see [16] for a recent survey. Most of these methods consider that the studied dynamic networks are represented as sequences of snapshots, with each snapshot being a well formed graph with meaningful community structure, see for instance [12,5]. Some other methods work with interval graphs, and update the community structure at each network change, e.g., [17,3]. However, all those methods are not adapted to deal with link streams, for which the network is usually not well formed at any given time. Using them on such a network would require to first aggregate the links of the stream by choosing an arbitrarily temporal scale (aggregation window). 2.2 Change Point Detection Our work is also related to research conducted on change point detection consid- ering community structures. In these approaches, given a sequence of snapshots, Detecting Stable Communities in Link Streams at Multiple Temporal Scales 3 one wants to detect the periods during which the network organization and/or the community structure remains stable. In [15], the authors proposed the first change-point detection method for evolving networks that uses generative net- work models and statistical hypothesis testing. Wang et al. [19] proposed a hi- erarchical change point detection method to detect both inter-community(local change) and intra-community(global change) evolution. A recent work by Ma- suda et al. [11] used graph distance measures and hierarchical clustering to iden- tify sequences of system state dynamics. From those methods, our proposal keeps the principle of stable periods de- limited by change points, and the idea of detecting changes at local and global scales. But our method differs in two directions: i) we are searching for stable individual communities instead of stable graph periods, and ii) we search for stable structures at multiple levels of temporal granularity. 3 Method The goal of our proposed method is i) to detect stable communities ii) at multiple scales without redundancy and iii) to do so efficiently. We adopt an iterative approach, searching communities from the coarser to the more detailed temporal scales. At each temporal scale, we use a three step process: 1. Seed Discovery, to find relevant community seeds at this temporal scale. 2. Seed Pruning, to remove seeds which are redundant with communities found at higher scales. 3. Seed Expansion, expanding seeds in time to discover stable communities. We start by presenting each of these three steps, and then we describe the method used to iterate through the different scales in section 3.4. Our work aims to provide a general framework that could serve as baseline for further work in this field. We define three generic functions that can be set according to the user needs: -- CD(g), a static community detection algorithm on a graph g. -- QC(N, g), a function to assess the quality of a community defined by the set of nodes N on a graph g. -- CSS(N1,N2), a function to assess the similarity of two sets of nodes N1 and N2. See section 3.5 on how to choose proper functions for those tasks. We define a stable dynamic community c as a triplet c = (N, p, γ), with c.N the list of nodes in the community, c.p its period of existence defined as an interval, e.g., c.p = [t1, t2[4 means that the community c exists from t1 to t2, and c.γ the temporal granularity at which c has been discovered. We denote the set of all stable dynamic communities D. 4We use right open intervals such as a community starting at tx and another one ending at the same tx have an empty intersection, which is necessary to have coherent results when handling discrete time steps. 4 S. Boudebza et al. 3.1 Seed Discovery For each temporal scale, we first search for interesting seeds. A temporal scale is defined by a granularity γ, expressed as a period of time (e.g.; 20 minutes, 1 hour, 2 weeks, etc).We use this granularity as a window size, and, starting from a time t0 -- by default, the date of the first observed interaction -- we create a cumulative graph (snapshot) for every period [t0, t0 +γ[, [t0 +γ, t0 +2γ[, [t0 +2γ, t0 +3γ[, etc., until all interactions belong to a cumulative graph. This process yields a sequence of static graphs, such as Gt0,γ is a cumulated snapshot of link stream G for the period starting at t0 and of duration γ. Gγ is the list of all such graphs. Given a static community detection algorithm CD yielding a set of commu- nities, and a function to assess the quality of communities QC, we apply CD on each snapshot and filter promising seeds, i.e., high quality communities, using QC. The set of valid seeds S is therefore defined as: S = {∀g ∈ Gγ,∀s ∈ CD(g), QC(s, g) > θq} (1) With θq a threshold of community quality. Since community detection at each step is independent, we can run it in parallel on all steps, this is an important aspect for scalability. 3.2 Seed Pruning The seed pruning step has a twofold objective: i) reducing redundancy and ii) speed up the multi-scale community detection process. Given a measure of structural similarity CSS, we prune the less interesting seeds, such as the set of filtered seeds FS is defined as: FS = {∀s ∈ S,∀c ∈ D, (CSS(s.N, c.N ) > θs) ∨ (s.p ∩ c.p = {∅}) (2) Where D is the set of stable communities discovered at coarser (or similar, see next section) scales, s.p is the interval corresponding to the snapshot at which this seed has been discovered, and θs is a threshold of similarity. Said otherwise, we keep as interesting seeds those that are not redundant topologically (in term of nodes/edges), OR not redundant temporally. A seed is kept if it corresponds to a situation never seen before. 3.3 Seed Expansion The aim of this step is to assess whether a seed corresponds to a stable dynamic community. The instability problem has been identified since the early stages of the dynamic community detection field [1]. It means that the same algorithm ran twice on the same network after introducing minor random modifications might yield very different results. As a consequence, one cannot know if the differences observed between the community structure found at t and at t + 1 are due to structural changes or to the instability of the algorithm. This problem Detecting Stable Communities in Link Streams at Multiple Temporal Scales 5 is usually solved by introducing smoothing techniques [16]. Our method use a similar approach, but instead of comparing communities found at step t and t − 1, we check whether a community found at t is still relevant in previous and following steps, recursively. More formally, for each seed s ∈ F S found on the graph Gt,γ, we iteratively expand the duration of the seed s.d = [t, t + γ[ (where t is the time start of this duration) at each step ti in both temporal directions (ti ∈ (...[t − 2γ, t − γ[, [t − γ, t]; [t + γ, t + 2γ[, [t + 2γ, t + 3γ]...)) as long as the quality QC(s.N, Gti,γ) of the community defined by the nodes s.N on the graph at Gti,γ is good enough. Here, we use the same similarity threshold θs as in the seed pruning step. If the final duration period s.p of the expanded seed is higher than a duration θpγ, with θp a threshold of stability, the expanded seed is added to the list of stable communities, otherwise, it is discarded. This step is formalized in Algorithm 1. Algorithm 1: Forward seed expansion. Forward temporal expansion of a seed s found at time t of granularity γ. The reciprocal algorithm is used for backward expansion: t + 1 becomes t − 1. Input: s, γ, θp, θs 1 t ← tstarts.p = [tstart, tend[ ; 2 g ← Gt,γ; 3 p ← [t, t + γ[; 4 while QC(s.N, g) > θs do 5 6 7 s.p ← s.p ∪ p; t ← t + γ; p ← [t, t + γ[; g ← Gt,γ; 8 9 end 10 if s.p ≥ θpγ then D ← D ∪ {s}; 11 12 end In order to select the most relevant stable communities, we consider seeds in descending order of their QC score, i.e., the seeds of higher quality scores are considered first. Due to the pruning strategy, a community of lowest quality might be pruned by a community of highest quality at the same granularity γ. 3.4 Multi-scale Iterative Process Until then, we have seen how communities are found for a particular time scale. In order to detect communities at multiple scales, we first define the ordered list of studied scales Γ . The largest scale is defined as γmax = G.d/θp, with G.d the total duration of the dynamic graph. Since we need to observe at least θp successive steps to consider the community stable, γmax is the largest scale at which communities can be found. We then define Γ as the ordered list: Γ = [γmax, γmax/21, γmax/22, γmax/23, ..., γmax/2k] (3) 6 S. Boudebza et al. With k such as γmax/2k > θγ >= γmax/2k+1, θγ being a parameter corre- sponding to the finest temporal granularity to evaluate, which is necessarily data-dependant (if time is represented as a continuous property, this value can be fixed at least at the sampling rate of data collection). This exponential reduction in the studied scale guarantees a limited number of scales to study. The process to find seeds and extend them into communities is then summa- rized in Algorithm 2. Algorithm 2: Multi-temporal-scale stable communities finding. Summary of the proposed method. See corresponding sections for the de- tails of each step. G is the link streams to analyze, θq, θs, θp, θγ are threshold parameters. 1 D ← {∅}; 2 Γ ←studied scales(G, θγ) ; 3 for γ ∈ Γ do Input: G, θq, θs, θp, θγ 4 5 6 7 S ← Seed Discovery(γ, CD, QC, θq); FS ←Seed Pruning(S, CSS, θs); for s ∈ FS do Seed Expansion(s, γ, θp, θs); end 8 9 end 3.5 Choosing Functions and Parameters The proposed method is a general framework that can be implemented using different functions for CD, QC and CSS. This section provides explicit guid- ance for selecting each function, and introduces the choices we make for the experimental section. Community Detection - CD Any algorithm for community detection could be used, including overlapping methods, since each community is considered as an independant seed. Following literature consensus, we use the Louvain method [2], which yields non-overlapping communities using a greedy modularity-maximization method. The louvain method performs well on static networks, it is in particular among the fastest and most efficient methods. Note that it would be meaningful to adopt an algorithm yielding communities of good quality according to the chosen QC, which is not the case in our experiments, as we wanted to use the most standard algorithms and quality functions in order to show the genericity of our approach. Quality of Communities - QC The QC quality function must express the quality of a set of nodes w.r.t a given network, unlike functions such as the modularity, which express the quality of a whole partition w.r.t a given network. Detecting Stable Communities in Link Streams at Multiple Temporal Scales 7 Many such functions exist, like Link Density or Scaled Density[7], but the most studied one is probably the Conductance [10]. Conductance is defined as the ratio of i)the number of edges between nodes inside the community and nodes outside the community, and ii)the sum of degrees of nodes inside the community (or outside, if this value is larger). More formally, the conductance φ of a community C is : (cid:80) i∈C,j /∈C Ai,j Where A is the adjacency matrix of the network, A(C) =(cid:80) M in(A(C), A( ¯C)) φ(C) = j∈V Ai,j and ¯C is the complement of C. Its value ranges from 0 (Best, all edges starting from nodes of the community are internal) to 1 (Worst, no edges between this community and the rest of the network). Since our generic framework expects good communities to have QC scores higher than the threshold θq, we adopt the definition QC=1-conductance. i∈C (cid:80) Community Seed Similarity - CSS This function takes as input two sets of nodes, and returns their similarity. Such a function is often used in dynamic community detection to assess the similarity between communities found in dif- ferent time steps. Following [5], we choose as a reference function the Jaccard Index.Given two sets A and B, it is defined as: J(A, B) = A∩B A∪B 3.6 Parameters The algorithm has four parameters, θγ, θq, θs, θp, defining different thresholds. We explicit them and provide the values used in the experiments. 1. θγ is data-dependant. It corresponds to the smallest temporal scale that will be studied, and should be set at least at the collection rate. For synthetic networks, it is set at 1 (the smallest temporal unit needed to generate a new stream), while, for SocioPatterns dataset, it is set to 20 secondes(the minimum length of time required to capture a contact). 2. θq determines the minimal quality a seed must have to be preserved and expanded. The higher this value, the more strict we are on the quality of communities. We set θq = 0.7 in all experiments. It is dependent on the choice of the QC function. 3. θs determines the threshold above which two communities are considered redundant. The higher this value, the more communities will be obtained. We set θs = 0.3 in all experiments. It is dependent on the choice of the CSS function. 4. θp is the minimum number of consecutive periods a seed must be expanded in order to be considered as stable community. We set θs = 3 in all experiments. The value should not be lower in order to avoid spurious detections due to pure chance. Higher values could be used to limit the number of results. 8 S. Boudebza et al. (a) Stable communities produced by the generator. (b) Stable communities discovered by the proposed method. Fig. 1: Visual comparison between planted and discovered communities. Time steps on the horizontal axis, nodes on the vertical axis. Colors correspond to communities and are randomly assigned. We can observe that most communities are correctly discovered, both in terms of nodes and of duration. 4 Experiments and Results The validation of our method encompasses three main aspects: i) the validity of communities found, and ii) the multi-scale aspect of our method, iii) its scal- ability. We conduct two kinds of experiments: on synthetic data, on which we use planted ground-truth to quantitatively compare our results, and on real net- works, on which we use both qualitative and quantitative evaluation to validate our method. 4.1 Validation on Synthetic Data To the best of our knowledge, no existing network generator allows to generate dynamic communities at multiple temporal scale. We therefore introduce a sim- 010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849010002000300040005000012345678910111213141516171819202122232425262728293031323334353637383940414243444546474849 Detecting Stable Communities in Link Streams at Multiple Temporal Scales 9 ple solution to do so. Let us consider a dynamic network composed of T steps and N different nodes. We start by adding some random noise: at each step, an Erdos-Renyi random graph[4] is generated, with a probability of edge pres- ence equal to p. We then add a number SC of random stable communities. For each community, we attribute randomly a set of n ∈ [4, N/4] nodes, a duration d ∈ [10, T /4] and a starting date s ∈ [0, T − d]. n and d are chosen using a log- arithmic probability, in order to increase variability. The temporal scale of the community is determined by the probability of observing an edge between any two of its nodes during the period of its existence, set as 10/d. As a consequence, a community of duration 10 will have edges between all of its nodes at every step of its existence, while a community of length 100 will have an edge between any two of its nodes only every 10 steps in average. Since no algorithm exists to detect communities at multiple temporal scales, we compare our solution to a baseline: communities found by a static algorithm on each window, for different window sizes. It corresponds to detect & match methods for dynamic community detection such as [5]. We then compare the results by computing the overlapping NMI as defined in [8], at each step. For those experiments, we set T = 5000, N = 100, p = 10/N . We vary the number of communities SC. t scale (γ) Proposed 1666 833 416 208 104 52 26 13 6 3 1 5 0.91 0.41 0.36 0.39 0.46 0.47 0.45 0.35 0.28 0.17 0.12 0.05 10 0.78 0.32 0.30 0.40 0.45 0.48 0.47 0.35 0.26 0.16 0.09 0.03 20 0.69 0.24 0.29 0.36 0.40 0.44 0.45 0.38 0.30 0.19 0.11 0.04 30 0.69 0.23 0.27 0.34 0.42 0.46 0.47 0.42 0.31 0.19 0.10 0.03 40 0.62 0.15 0.23 0.32 0.41 0.45 0.47 0.42 0.32 0.20 0.12 0.05 50 0.54 0.19 0.25 0.33 0.37 0.42 0.45 0.41 0.31 0.19 0.11 0.04 Table 1: Comparison of the Average NMI scores(over 10 runs) obtained for the proposed method (Proposed ) and for each of the temporal scales (γ ∈ Γ ) used by the proposed method, taken independently. Figure 1 represents the synthetic communities to find for SC = 10, and the communities discovered by the proposed method. We can observe a good match, with communities discovered throughout multiple scales (short-lasting and long- lasting ones). We report the results of the comparison with baselines in table 1. We can observe that the proposed method outperforms the baseline at every scale in all cases in term of average NMI. 10 S. Boudebza et al. The important implication is that the problem of dynamic community de- tection is not only a question of choosing the right scale through a window size, but that if the network contains communities at multiple temporal scale, one needs to use an adapted method to discover them. 4.2 Validation on Real Datasets We validate our approach by applying it to two real datasets. Because no ground truth data exists to compare our results with, we validate our method by using both quantitative and qualitative evaluation. We use the quantitative approach to analyze the scalability of the method and the characteristics of communities discovered compared with other existing algorithms. We use the qualitative ap- proach to show that the communities found are meaningful and could allow an analyst to uncover interesting patterns in a dynamic datasets. The datasets used are the following: -- SocioPatterns primary school data[18], face-to-face interactions between children in a school (323 nodes, 125 773 interaction). -- Math overflow stack exchange interaction dataset [14], a larger network to evaluate scalability (24 818 nodes, 506 550 interactions). Qualitative evaluation For the qualitative evaluation, we used the primary school data[18] collected by the SocioPatterns collaboration 5 using RFID de- vices. They capture face-to-face proximity of individuals wearing them, at a rate of one capture every 20 seconds. The dataset contains face-to-face interactions between 323 children and 10 teachers collected over two consecutive days in Oc- tober 2009. This school has 5 levels, each level is divided into 2 classes(A and B), for a total of 10 classes. No community ground truth data exists to validate quantitatively our find- ings. We therefore focus on the descriptive information highlighted on the So- cioPatterns study [18], and we show how the results yielded by our method match the course of the day as recorded by the authors in this study. In order to make an accurate analysis of our results, the visualization have been reduced to one day (the second day), and we limited ourselves to 4 classes (1B, 2B, 3B, 5B) 6. 120 communities are discovered in total on this dataset. We created three different figures, corresponding to communities of length re- spectively i)less than half an hour, ii) between half an hour and 2 hours, iii) more than 2 hours. Figure 2 depicts the results. Nodes affiliations are ordered by class, as marked on the right side of the figure. The following observations can be made: -- Communities having the longest period of existence clearly correspond to the class structure. Similar communities had been found by the authors of the original study using aggregated networks per day. 5www.sociopatterns.org 6Note that full results can be explored online using the provided notebook (see conclusion section) Detecting Stable Communities in Link Streams at Multiple Temporal Scales 11 (a) Second day, length<30min. Grey vertical areas corre- spond to most likely break periods. (b) Second day, 30min<length<2hours. Grey vertical area corresponds to the lunch break (c) Second day, length>2hours Fig. 2: Stable communities of different lengths on the SocioPatterns Primary School Dataset. Time on the horizontal axis, children on the vertical axis. Colors are attributed randomly. -- Most communities of the shorter duration are detected during what are prob- ably breaks between classes. In the original study, it had been noted that break periods are marked by the highest interaction rates. We know from 12 S. Boudebza et al. data description that classes have 20/30 minutes breaks, and that those breaks are not necessarily synchronized between classes. This is compatible with observation, in particular with communities found between 10:00 and 10:30 in the morning, and between 4:00 and 4:30 in the afternoon. -- Most communities of medium duration occur during the lunch break. We can also observe that the most communities are separated into two intervals, 12:00-13:00 and 13:00-14:00. This can be explained by the fact that children have a common canteen, and a shared playground. As the playground and the canteen do not have enough capacity to host all the students at the same time, only two or three classes have breaks at the same time, and lunches are taken in two consecutive turns of one hour. Some children do not belong to any communities during the lunch period, which matches the information that about half of the children come back home for lunch [18]. -- During lunch breaks and class breaks, some communities involve children from different classes, see the community with dark-green colour during lunch time (medium duration figure) or the pink community around 10:00 for short communities, when classes 2B and 3B are probably in break at the same time. This confirms that an analysis at coarser scales only can be misleading, as it leads only to the detection of the stronger class structure, ignoring that communities exist between classes too, during shorter periods. Quantitative evaluation In this section, we compare our proposition with other methods on two aspects: scalability, and aggregated properties of commu- nities found. The methods we compare ourselves to are: -- An Identify and Match framework proposed by Greene et al. [5]. We imple- ment it using the Louvain method for community detection, and the Jaccard coefficient to match communities, with a minimal similarity threshold of 0.7. We used a custom implementation, sharing the community detection phase with our method. -- The multislice method introduced by Mucha et al. [12]. We used the authors implementation, with interslice coupling ω = 0.5. -- The dynamic clique percolation method (D-CPM) introduced by Palla et al. [13]. We used a custom implementation, the detection in each snapshot is done using the implementation in the networkx library [6]. For Identify and Match, D-CPM and our approach, the community detection phase is performed in parallel for all snapshots. This is not possible for Mucha et al., since the method is performed on all snapshots simultaneously. On the other hand, D-CPM and Indentify and Match are methods with no dynamic smoothing. Figure 3 presents the time taken by those methods and our proposition, for each temporal granularity, on the Math Overflow network. The task accom- plished by our method is, of course, not comparable, since it must not only dis- cover communities, but also avoid redundancy between communities in different temporal scales, while other methods yield redundant communities in different Detecting Stable Communities in Link Streams at Multiple Temporal Scales 13 Fig. 3: Speed of several dynamic community detection methods for several tem- poral granularities, on the Math Overflow dataset. Missing points correspond to computation time above 1000s. Temporal scales correspond to window sizes and are divided by 2 at every level, from 1=67 681 200s (about 2 years) to 10=132 189s (about 36h). OUR and OUR-MP corresponds to our method using or not multiprocessing (4 cores) levels. Nevertheless, we can observe that the method is scalable to networks with tens of thousands of nodes and hundreds of thousands of interactions. It is slower than the Identify and Match(CD&Match) approach, but does not suffer from the scalability problem as for the two other ones(D-CPM and Mucha et al.,). In particular, the clique percolation method is not scalable to large and dense networks, a known problem due to the exponential growth in the number of cliques to find. For the method by Mucha et al., the scalability issue is due to the memory representation of a single modularity matrix for all snapshots. Method OUR CD&MATCH 29846 CPM MUCHA 3259 1097 3.44 1.21 1.87 15.48 10.89 1.00 5.50 0.97 5.37 0.51 9.72 0.62 #Communities Persistance Size Stability Density Q 179 0.50 0.42 0.01 0.38 0.91 0.96 0.53 0.85 Table 2: Average properties of communities found by each method (indepen- dently of their temporal granularity). #Communities: number of communities found. Persistence: number of consecutive snapshots. Size: number of nodes. Stability: average Jaccard coefficient between nodes of the same community in successive snapshots. Density: average degree/size-1. Q: 1-Conductance (higher is better) 110100100012345678910Running time (s)Temporal scaleOUR - MPCD & matchMuchaCPMOUR 14 S. Boudebza et al. In table 2, we summarize the number of communities found by each method, their persistence, size, stability, density and conductance. It is not possible to formally rank those methods based on these values only, that correspond to vastly different scenarios. What we can observe is that existing methods yield much more communities than the method we propose, usually at the cost of lower overall quality. When digging into the results, it is clear that other methods yield many noisy communities, either found on a single snapshot for methods without smoothing, unstable for the smoothed Mucha method, and often with low density or Q. 5 Conclusion and future work To conclude, this article only scratches the surface of the possibilities of multiple- temporal-scale community detection. We have proposed a first method for the detection of such structures, that we validated on both synthetic and real-world networks, highlighting the interest of such an approach. The method is proposed as a general, extensible framework, and its code is available 78as an easy to use library, for replications, applications and extensions. As an exploratory work, further investigations and improvements are needed. Heuristics or statistical selection procedures could be implemented to reduce the computational complexity. Hierarchical organization of relations -- both temporal and structural -- between communities could greatly simplify the interpretation of results. References 1. Aynaud, T., Guillaume, J.L.: Static community detection algorithms for evolv- ing networks. In: 8th International Symposium on Modeling and Optimization in Mobile, Ad Hoc, and Wireless Networks. pp. 513 -- 519. IEEE (2010) 2. Blondel, V.D., Guillaume, J.L., Lambiotte, R., Lefebvre, E.: Fast unfolding of com- munities in large networks. Journal of statistical mechanics: theory and experiment 2008(10), P10008 (2008) 3. Boudebza, S., Cazabet, R., Azouaou, F., Nouali, O.: Olcpm: An online framework for detecting overlapping communities in dynamic social networks. Computer Com- munications 123, 36 -- 51 (2018) 4. Erdos, P., R´enyi, A.: On random graphs i. Publicationes Mathematicae Debrecen 6, 290 -- 297 (1959) 5. Greene, D., Doyle, D., Cunningham, P.: Tracking the evolution of communities in dynamic social networks. In: 2010 international conference on advances in social networks analysis and mining. pp. 176 -- 183. IEEE (2010) 7The full code is available at https://github.com/Yquetzal/ECML_PKDD_ 2019 8An online notebook to test the method is available at https://colab. research.google.com/github/Yquetzal/ECML_PKDD_2019/blob/master/ simple_demo.ipynb Detecting Stable Communities in Link Streams at Multiple Temporal Scales 15 6. Hagberg, A., Swart, P., S Chult, D.: Exploring network structure, dynamics, and function using networkx. Tech. rep., Los Alamos National Lab.(LANL), Los Alamos, NM (United States) (2008) 7. Labatut, V., Orman, G.K.: Community Structure Characterization, pp. 1 -- 13. Springer New York, New York, NY (2017) 8. Lancichinetti, A., Fortunato, S., Kert´esz, J.: Detecting the overlapping and hier- archical community structure in complex networks. New Journal of Physics 11(3), 033015 (2009) 9. Latapy, M., Viard, T., Magnien, C.: Stream graphs and link streams for the mod- eling of interactions over time. CoRR abs/1710.04073 (2017) 10. Leskovec, J., Lang, K.J., Dasgupta, A., Mahoney, M.W.: Community structure in large networks: Natural cluster sizes and the absence of large well-defined clusters. Internet Mathematics 6(1), 29 -- 123 (2009) 11. Masuda, N., Holme, P.: Detecting sequences of system states in temporal networks. Scientific Reports 9(1) (1 2019). https://doi.org/10.1038/s41598-018-37534-2 12. Mucha, P.J., Richardson, T., Macon, K., Porter, M.A., Onnela, J.P.: Commu- nity structure in time-dependent, multiscale, and multiplex networks. science 328(5980), 876 -- 878 (2010) 13. Palla, G., Barab´asi, A.L., Vicsek, T.: Quantifying social group evolution. Nature 446(7136), 664 (2007) 14. Paranjape, A., Benson, A.R., Leskovec, J.: Motifs in temporal networks. In: Pro- ceedings of the Tenth ACM International Conference on Web Search and Data Mining. pp. 601 -- 610. ACM (2017) 15. Peel, L., Clauset, A.: Detecting change points in the large-scale structure of evolv- ing networks. CoRR abs/1403.0989 (2014) 16. Rossetti, G., Cazabet, R.: Community discovery in dynamic networks: a survey. ACM Computing Surveys (CSUR) 51(2), 35 (2018) 17. Rossetti, G., Pappalardo, L., Pedreschi, D., Giannotti, F.: Tiles: an online al- gorithm for community discovery in dynamic social networks. Machine Learning 106(8), 1213 -- 1241 (2017) 18. Stehl´e, J., Voirin, N., Barrat, A., Cattuto, C., Isella, L., Pinton, J., Quaggiotto, M., Van den Broeck, W., R´egis, C., Lina, B., Vanhems, P.: High-resolution mea- surements of face-to-face contact patterns in a primary school. PLOS ONE 6(8), e23176 (08 2011). https://doi.org/10.1371/journal.pone.0023176 19. Wang, Y., Chakrabarti, A., Sivakoff, D., Parthasarathy, S.: Fast change point de- tection on dynamic social networks. In: Proceedings of the 26th International Joint Conference on Artificial Intelligence. pp. 2992 -- 2998. IJCAI'17, AAAI Press (2017)
1709.04767
1
1709
2017-09-14T13:15:17
A review of approaches to the value of privacy
[ "cs.SI", "cs.CR" ]
In this paper we examine information privacy from a value-centered angle. We review and compare different personal data valuation approaches. We consider the value of personal data now and in the near future, and we find that the enduring part of personal data will soon become common knowledge and that their price and value will drop substantially. Therefore the sector that is based on personal data extraction will need to focus on new ways of monetization and on the of the dynamic part of personal information.
cs.SI
cs
A review of approaches to the value of privacy Miltiades E. Anagnostou1 and Maria A. Lambrou2 1School of Electrical and Computer Engineering, National Technical University of Athens, Zografou 15780, Greece, email:[email protected] 2Dept. of Shipping Trade and Transport, University of the Aegean, Chios 82132, Greece, email:[email protected] October 10, 2018 Abstract In this paper we examine information privacy from a value-centered an- gle. We review and compare different personal data valuation approaches. We consider the value of personal data now and in the near future, and we find that the enduring part of personal data will soon become common knowledge and that their price and value will drop substantially. There- fore the sector that is based on personal data extraction will need to focus on new ways of monetization and on the of the dynamic part of personal information. Keywords: Privacy, price of privacy, value of privacy, personal data, social networking 1 Introduction In a classical definition privacy is a special case of a right to be let alone [WB90]. In the Random House Unabridged Dictionary privacy is the state of being free from unwanted or undue intrusion or disturbance in one's private life or affairs; freedom to be let alone. Tavani distinguishes between three types of privacy [Tav11]: (a) Accessibility (related with physical space), (b) decisional (right to make decisions freely), and (c) informational privacy, the latter being defined as control over the flow of one's personal information. According to EU Regulation 2016/679 the protection of natural persons in relation to the processing of per- sonal data is a fundamental right, where "personal data" means any information relating to an identified or identifiable natural person. Of particular importance are the sensitive personal data, which are personal data revealing racial or ethnic origin, political opinions, religious or philosophical beliefs, trade-union member- ship, and data concerning health or sex life. In this paper, we explore the privacy protection problem, both for online social networks and generic e-service systems, from a value-centered angle. 1 2 Value is created by using personal data 2.1 Value of personal data and value of services There is a realm of apps and services, which includes social networking, that are provided for "free," subject to user consent to privacy related terms. Ser- vice providers record and analyze user behavior for their own financial support, which is achieved mostly by targeted advertising. Users, who are aware of these practices may want to protect their personal data, sell them for a satisfactory price, or just wonder whether "free" services are a fair compensation. Most "free" services are advertisement supported. The less digitally literate user is under the impression that a possible service subscription is avoided by consenting to the occasional addition of random advertisements to the service. However, more the literate user knows that advertisements are targeted, their selection being based on the user's recorded behavior during interaction with the service or with other services, which sometimes are offered by other providers. Effectively it is the value of user's personal data that somehow balances a pos- sible service subscription. Service subscriptions are not expected to exceed a few dollars per month. Popular paid services, with which a user could make comparisons, are in the order of magnitude of $10; known examples are Netflix and Spotify. Social media typically avoid the subscription model, thus no direct comparisons can be made, but the users' expectations would probably be in the same order of magnitude. Effectively, a user's personal data are exchanged with services that are worth a few dollars. This fact creates in the user's mind the impression that privacy itself is of low value. We shall see later that field research confirms this impression. On the other hand Google and Facebook have continuously expanded their percentage in the technology sector stock market by squeezing the share of more traditional technology giants as IBM, Microsoft, Cisco and Apple [eco]. Apparently, gigan- tic amounts of monetary value are produced by offering "free" search and social networking services, entailing to a considerable extent privacy engineering. Fur- thermore, a flourishing (albeit quietly working) personal data brokerage market exists. Effectively there seems to be a remarkably wide gap between (i) the value attributed to personal data by the data originators, who give the data for free and (ii) the revenues created by the aforementioned and other companies and organizations by using these data. The data using entities are effectively "machines" that convert personal and other data into unprecedented profits. Of course this is not the first time that information is monetized. However, personal information is not exactly like any other type of information. Do the aforementioned considerations imply that service users (who sell privacy data low) are unfairly treated by service providers (who achieve high profits)? In some cases, as in YouTube, the company declares the exact amount of money that goes back to users as content creators, but social media users are not in a position to assess the balance between the profits of the social network provider and the value of the services offered to them. 2 3 Personal data value estimation approaches 3.1 Market based approach The price of a product or service is usually determined by a market, and value estimates are not independent of markets. Ideally we would find the value and price of a personal data set in a market. However, such a market between data creators and data users rarely exists. Suppose that I install in my computer a data logging software that records certain actions of mine and I decide to sell the log of one month; there is no market for such a transaction. Conversely, suppose that a company is willing to access my recorded behavior in a series of specific transactions on a given service interface. They could make me an offer for this data set, which has been created by the interaction of their service with me, but they invariably ask for my consent to allow them to receive this data stream for free. In certain situations I could infer the profits of a company by using my personal data from existing options. For example Spotify offers ad free mu- sic streaming for e5-14 per month (depending on the country). Alternatively, a free service is offered with ads, and weaker sequencing control of songs on mobile phones. Effectively Spotify quits inserting advertisements and (maybe) collecting my data for the above price. Although the pricing is certain to take into account the expected balance between paying and non-paying customers, the aforementioned price remains a strong indication of the personal data value. On the other hand Wolfram, whose highly sophisticated product Mathematica is priced in the thousands of dollars, is probably not concerned with user data. There is yet another missing factor, namely the customer's quantified will- ingness to pay for a service, i.e. the service value as estimated by the customer. Suppose that a social network user is offered a no-ads - no-tracking option for a paid subscription. How much would the average user be willing to pay for such an option? Most probably, taking into account the aforementioned price of subscriptions of streaming, gaming etc. services, a realistic price for social networking services is in the range $5 − 20. Yet another privacy value indication is likely to appear soon by Google, which has declared an intention to allow content publishers to charge for the content in the presence of ad blockers [Ram17]. While this looks like a non- disturbance buy price, it will become a service sell price if publishers set the prices according to a content valuation scheme. Alternatively, they may try to set a price that will offset the loss due to ad blockers, or to set a more or less flat "fine" that will deter blocker usage. Notice that these are quite different valuation methodologies, and that some of them may lead to irrational effects. Consider the following example: You start a video on a website, but before it starts an advertisement tries to pop up. If it is blocked, a window appears that asks for a payment. While you would expect the price to somehow reflect the value of the content, if it is just an offset to the expected advertisement gain (or even worse if it is a flat "fine"), the connection between the real content value and the price that appears on the window is lost (due to the possibility to insert an ad before the video). The only connection that remains is that a more efficient advertisement is likely to appear together with a more highly valued video. In view of the haziness in today's landscape, some researchers have proposed 3 clearer arrangements. Perhaps we should pay a small amount each time we receive a service, and the service provider should pay us for our personal data sets or should return to us a part of their profits [BS03]. However, we shall not consider this category of models in this paper. While in practice there is hardly a market to sell your own personal data, there is definitely a market for resellers of your data packed together with the data of millions of others. Despite the numerous personal and sensitive data protection laws there is a market for personal data, brokers exist, buyers also exist and, obviously, there are initial sellers that harvest the data in the first place and sell them to the brokers, unless we assume that all data offered by resellers are products of security breaches. According to Pasquale [Pas14] per- sonal data markets were already a $156-billion-a-year industry in 2014 in US, but the Federal Trade Commission (FTC) could find neither the data sources nor the final consumers. Not only the data are sold in a black underground market, but they are also often used for unlawful purposes. In 2014 in a report of FTC [ftc14] the results of exploring the behavior of nine data brokers are outlined: The data are collected without consumers' knowledge; brokers buy data from different sources and exchange data with each other; the population coverage is almost complete and extensive per person; the data are analyzed and potentially sensitive inferences are made. However the differential value of additional data is likely to be strongly decreasing. Kosinski says that about 300 Likes on Facebook are enough to predict sensitive undisclosed traits of a person with an accuracy close to 100% [YKS15]. Therefore the next few Likes will add nothing to a person's already complete picture. Since data brokers exchange, mix, and improve datasets, everybody's permanent picture will be complete in short time and additional data will add zero information. 3.2 Indirect privacy value estimations Unfortunately, the informational privacy bears on other types of privacy, i.e. on accessibility and on decisional privacy ([Tav11], see also section 1). For some people a misuse of their personal data violates their abstract notion of privacy, to which they attribute value without being willing to take steps to further elab- orate on specific and concrete problems that are created or may be created by the aforementioned misuse. Persons of this type may be reluctant to join social networks and may provide minimum personal information to online shopping sites; thus they are not willing to contribute to the creation and circulation of personal data. Perhaps their behavior provides an indication that the value they attribute to privacy is higher than average. Is it possible to find out how these persons valuate their privacy? According to Marion Fourcade if people mobilize and defend certain "things," then these things must have value, even if they are not readily tradable or they do not appear in markets. Moreover, the trade-offs that people make to pursue them are a good enough indication of the monetary value they implicitly attach to them [Fou11]. Fourcade gives an example of value estimation: What is the value of a pristine albeit difficult to access beach? It is higher than the value of our usual beach at least by an amount of money v, which is equal to the additional cost to travel to the better beach. The maximum such differential amount (paid by the most remote travelers) will give the additional value. 4 For example, if the average person in a given social environment is a member of certain social networks, and uses a number of other services, which extract personal data, and if we somehow calculate the value of all these social network- ing and other services to an amount V, then an abstainer that lives in the same environment values his or her privacy more than V. We might be tempted to use this methodology in order to calculate a value for our personal data despite the fact that we do not intend to sell them. One might say that the value of our personal data is equal to the maximum amount of money we are willing to pay for their protection. However, the situation is similar to an insurance related decision. The amount of money that we are willing to pay for the insurance of a house is not equal to the value of the house, but is rather in the order of magnitude of the house value times the probability that it will be destroyed. Therefore in order to use this methodology we would have to know both possible damages and associated probabilities. Actually this brings us closer to the damage base approach, which we analyze in one of the forthcoming sections. 3.3 Subjective valuation As a matter of fact privacy champions are few, while the personal data of the majority of the population are open to being harvested. There has been several studies that try to assess the value of personal data as estimated by their own producers, i.e. the persons involved in their creation. Carrascal et al have conducted a study with an aim to estimate the value that users attached to their own personal data [CRE+13] in 2013 in Spain. Users of online services were paid for their personal data according to a reverse second price auction. The study has found that users valued certain "identity" data about themselves (i.e. age, gender, address, economic status, thus permanent data) at about e25, while they were willing to give away data collected during their browsing activity for only e7. They could also "sell" their photos to social networks for e12 and to search service providers for e2. Effectively, they valued their personal information at about a few tens of US dollars, often much less. In 2012 Beresford et al [BKP12] have conducted a field experiment, in which they sold two similar DVDs online, but they offered the second DVD for a somewhat reduced price (e1 cheaper) while asking for the buyer's personal details. They found that almost all users chose the cheaper product. When they set equal prices to both DVDs, buyers bought almost equal quantities, hence the title of their article "unwillingness to pay for privacy." A meta-study created by Baruh et al [BSC17], i.e. a study that combines results from several previous studies, has concluded the following: (a) Users with enhanced privacy concerns are less likely to use online services, with the marked exception of social media (see next paragraph). (b) Concerned users share less information and adopt more privacy protective measures. (c) However, digitally literate users tend to feel more comfortable with using online services. In another established trend in field studies, users of social media [BSC17] are less concerned about privacy. They express personal opinions and upload content in public. The reduced privacy "paradox" that is associated with so- cial media can be attributed mainly to self-fulfillment and self-promotion traits. However the fact that users tolerate the harvesting of their behavioral and other data by the social network provider can also be attributed to the effectively mo- 5 nopolistic nature of social media like Facebook or Instagram. The third person bias has been offered as yet another explanatory argument by [CPN]: Users tend to believe that the risks will only materialize on others. 3.4 The damage based approach Damage based methodologies are popular in courts for the calculation of com- pensations, but they can also be used in a more general context. When a person's data end up in somebody else's possession, any control over their usage is lost. Given today's landscape, in which data are legally and illegally collected, sold, resold, intercepted, etc., and further used in uncontrolled and unforeseen ways, the damage that may result is extremely difficult to predict. Even past damages are difficult to assess. To the uncertainty in data dissemination one should in the near future add increased dangers due to smart objects. A person's medical record leakage could in the past have led to a rejection of a job application, but tomorrow the same knowledge combined with a hack of this person's smart medication tracking system may end up in a murder. Anyhow, the value of data is often assessed by making reference to possible damage resulting by leakage, according to different scenarios and probabilities. A more general damage and compensation approach can also be applied. For example, if targeted ads take an hour of one's time when using a social network app, the value of the resulting disturbance could be set equal to one hour's average payment. As an example, suppose that a "free" audio streaming service inserts one 2 minute ad every 10 minutes. If a person is likely to use the service 5 hours per month, and if her hourly wage is $8, then her monthly annoyance is equivalent to 2 × 8 × 5 = 8 $. If the streaming service is priced to $7 per month, both options are roughly equivalent. 10 However, damage calculations are less convenient (a) when the damage is totally subjective, e.g. when she feels uncomfortable with her neighbors if they know her medical history, (b) when the harm is done without the person's knowl- edge [Lan16], (c) when the damage cannot be easily quantified, (d) when the harm is done at a later time, and (e) when calculation is simply too complex. Consider the scenario implied by articles [GK17, AH17], i.e. alleged manipula- tion of voters in general elections by exploiting personal data harvested by social networks. Possible damages extend over an entire population, are extremely dif- ficult to calculate, and sufficient information may not be available before several decades. Last but not least in the same example, the damage could be purely ethical: Are we willing to bend the democracy rules, even if the data have been exploited by the ideal candidate? The utilitarian answer to ethical, environ- mental and other intangible criteria is that the gain/loss calculation should be applied over a sufficiently broad context, i.e. given enough time and space, but this again ends up with a very complex calculation. 3.5 The revenues approach In 2008 Enders et al. [EHDM08] surveyed a number of social networking sites and explored their revenue models. The top 5 sites were MySpace, Classmates, Orkut, Friendster and Spoke, with 130, 40, 37, 36, and 35 million users respec- tively. Facebook users were only 13 million at the time (now more than two 6 billion). All of them relied on advertising, while Classmates used subscriptions too. Nine years later (in June 2017) the top five sites were Facebook, YouTube, Instagram, Twitter, and Reddit with 1940, 1000, 700, 313, and 250 million users respectively [Kal17]. The videos of YouTube (which is owned by Google) are accompanied by advertisements, but 55% of the revenues are returned to video creators through the YouTube Partner Program. Effectively the YouTube model relies heavily on user creativity. Instagram also relies on advertisement since its acquisition by Facebook (2012). Twitter makes money through direct ads and by encouraging people to tweet about a brand for a reward. Reddit uses a complicated mixed model that relies on community support, advertisement and subscriptions. Reddit claims that it does not track users. The total revenue from advertisement that was gained by social networks in 2016 was about $33 billion. Facebook's share was about 2/3 of the 33 billion. In 2017 Facebook alone is expected to reach 33 billion [Bak, Buy]. Facebook's average revenue per user (ARPU) was $4.23 in the first quarter of 2017 [Bal, Sta17]. A linear projection would give an annual ARPU of $17, but until the end of 2017 it will probably reach $20. This is significant progress from an ARPU of around $2 in 2009, and a significant growth since last year. About half of these revenues come from the mobile app. What is the total value that a user brings to Facebook? If we calculate the total revenues during the so far life of Facebook, these are close to $80 billion, but they have been accumulated by a changing size of population. If we sum up the yearly ARPU in the last ten years, the result is about $52; this is approximately the revenue brought by a ten year "old" Facebook member. However, a person's value for a social network is not equal to the value of the corresponding personal data. A social network makes money even from the mere membership of an otherwise inactive member, due to the network externalities phenomenon. Size counts for social networks. 3.6 Taking into account the market value of vendors As we have said before, Google and Facebook have recently dominated the tech- nology sector. However, Facebook is not a capital intensive company. Facebook owned network equipment equal to $3.63 billion in 2015 [Dat15]. If the current population is taken into account we could estimate the current equipment to 4.5 billion. Of course Facebook needs more than servers, which reside in huge data centers (or server farms). However, the company's value in the stock market (market capitalization) is around $336 billion. Effectively, the per user current value of Facebook is equal to 336/2 = $168. Even if we subtract a 10% for "hardware" (that includes the real estate) and operating costs, we can estimate the intangible per user value of Facebook around $150. Which part of this amount could be attributed to users' personal data is for further discussion. One might further argue that market capitalization includes certain intangible factors too, e.g. shareholders' expectations for the future of a company. Anyhow, the amount of $150 should be seen as a (perhaps not so tight) upper bound on the current user data value. Note that Facebook's capitalization value is approximately equal to its val- uation over a four year period, assuming that the valuation includes existing assets and future earning over a given time period. Such a valuation is usual when a company is about to enter the stock market. 7 4 Privacy in social media In this section we explore the special relationship between privacy and social media. Online social networking plays an exceptional role both in gathering data and in using data for producing revenues. Members willingly disclose personal and often sensitive information for the sake of participation and belonging. 4.1 The privileged relationship between social networking and personal data collection Privacy was unknown in traditional societies. Cohesion was an effective de- fensive weapon of small communities. A sharp division between us and them existed [Dia13]. Modern cities brought privacy, but also dismantled community ties. Social networks capitalize on such problems by partly restoring ties. Peo- ple effectively turn to the services of Facebook, LinkedIn, Google+, Instagram, Foursquare etc. and willingly reveal personal details, even secrets. However, the total online behavior of service users is recorded. Personal data streams are generated, collected, sold, resold, exchanged, combined, and processed. Not only are the social media the best place to collect personal data, but any privacy concerns are also neglected by their users [CPN]. In addition, the results and conclusions that are generated are not limited to the obvious. Sky is the limit to the science of information processing and inference making. According to [KSG13, YKS15] sensitive private traits can be uncovered by examining a number of Likes on Facebook. Such powerful tools could open new prospects to marketers, extortionists, political parties, religious parties etc. Allegations for political manipulation have already appeared in the press [GK17]. 4.2 The major revenue models Is personal data harvesting the only means of financially supporting a social networking service? In fact the known revenue tools in the area of social net- working are (a) advertising, (b) subscription, and (c) transaction models, which involve transaction fees, and sales of products and/or services. The latter can be generated by the network provider, by a third party, or by users. Both (a) and (c) require a critical mass of users [EHDM08]. There is often a prevalent tool, which accounts for the greatest part of the revenues and defines the character of the network. A user's reaction to a subscription is different from a reaction to an one time fee. Service providers prefer longer time relationships with users, i.e. subscriptions. There is discussion and criticism on the tendency of users towards "free" services and on the resulting implications on the world of Internet. However, the preference of service providers for subscription schemes (in telephony, in press, in magazines, in clubs etc.) has also played an important role, since they have taught the customer base that there is nothing between a free service and a monthly subscription service. Today's service management tools could possibly enable very short term subscriptions or even a fee per single transaction. For example, why should I be tied to a specific mobile telephony and data provider? Why can't I have an account with multiple (or all) providers and choose the best service on a transaction basis? Service providers dislike any 8 increase in competition that will suppress prices, but customers should be more active in demanding alternative arrangements. There are indications of change. Streaming content providers now offer subscriptions with a "cancel anytime" option. 4.3 The role of network externalities In social networking an already grown social network will attract more new users than a young one, since the existing user base largely determines the networking opportunities of new users. This phenomenon is known as network externalities or network effects [SV98]. In 2014 Ello was created as an ad-free alternative to existing social networks. In the beginning they used an invitation policy and they gathered some momentum. However, it soon became clear to new members that their friends stayed back in the traditional large and ad infested social networks; the momentum was lost. Today Ello is not really a Facebook competitor but rather a specialized artists' network. By promoting a "free" social networking service model, Facebook and other networks are able to better exploit network externalities and get rid of com- petition in a possible market of different social networking services differently priced. Of course creating a "free" service by using advertisement is not new, as it has extendedly been used for decades by traditional TV networks, and it is now used by the "free press." The novelty lies in the extensive usage of personal data. Consider a world of social networking sites that use a paid subscription model. A newcomer in this market would perhaps offer a free trial period, while waiting for the first generation of subscribers. Old established networks could charge more due to their increased user populations. In fact they would probably consider an optimized policy that would take into account the increase of the population in the total revenue. 4.4 Privacy policies in social networks Social networks are huge personal data collectors. Members willingly provide in- formation hoping that in this manner they will improve their chances to network themselves with past or future friends. A privacy policy is implemented by using rules, which are described in a document, but they must also be publicly accessible on a webpage and they must be written in easy to understand language. Since Facebook is the most often quoted example of information collecting and sharing network, we take some time to review their current privacy policy (June 2017). They state that they track their users from what they themselves write or upload, and from what other users write or upload. They say that they use this information to show their users targeted ads. They share user information within the Facebook family of companies, and they transfer information to third parties that support Facebook's operations by measuring the effectiveness of ads. They also give anonymized data to academic researchers. Apparently, this privacy policy does not allow Facebook to sell data to third parties. Terms change from time to time in directions of reduced or increased privacy, trying to accommodate new interests or to make corrections after user protests. There is also a set of privacy settings, which allow for some user customization. However, Fuchs [Fuc12] 9 observes that privacy settings are available and work only against other users, not against advertisers. 5 Other considerations 5.1 Upper bounds on value Even if a value for personal data could be determined by complex market mech- anisms or other methodologies, certain external bounds are also applicable. For example, no food seller can expect to gain from me by analyzing my recorded behavior more than the amount of money I spend for food in a given time pe- riod. Effectively, the value of my (food related) personal data would rather be a reasonably small percentage of my total food expenses. As a further example, consider the usage of social networking data in elec- tions, in the spirit of the article of Grassegger and Krogerus [GK17]. In this scenario a political party or their consultants ask for the personal data of a user of a social network. The network provider sells the data for a price, but a per- centage goes as a payment to the person that owns the data and has approved the exchange. Again, it is difficult to determine a value for such an item, as it depends, among other factors, on the probability that the data will finally be converted to a favorable vote. And even if a vote does materialize, how critical is this vote for winning the election? Note also that there may exist alternative means towards the same end, and these alternatives imply price limits. For ex- ample, in a corrupt democracy certain politicians will directly buy votes, thus the vote street price will be an upper bound to the value of the personal data that may lead to winning a vote. 5.2 Transaction models and and data exchange Most users would probably answer that in principle they would benefit from increased privacy protection, despite the fact that in practice they give up too easily. However Varian [Var02] has given certain examples on how a potential buyer could improve the effectiveness of an exchange by giving more information to potential sellers. Assume that a person receives multiple messages from telecom operator agents trying to sell telephony subscriptions. The fact that the sales person is not fully aware of the preferences and the statistical profile of the phone calls of the client creates a discussion that is both annoying and time consuming. In other words, if the seller knew more about the client, then she could probably make a more targeted offer or would abstain from making an offer. In this model, the client is motivated to give up privacy in favor of both better services and less annoyance. In fact this argument is not particularly original, as it is used every time we accept a first party cookie that is used by our service provider in order to serve us better without having to ask again about our preferences. Since privacy is the right to be left alone, Varian's way is to include the lack of annoyance in privacy. On the other hand, there are other types of information that we, as buyers, would not like to share with sellers. For example, we would keep the maxi- mum price we would be willing to pay for a good secret. Effectively, w.r.t. to 10 maximizing our benefit, including privacy aspects, we should be able to distin- guish between information that we should give for free to the other side and information that we should keep for ourselves. Note also that the value of the aforementioned maximum price information is equal to the expected gain (for the seller) or loss (for the buyer) when this piece of information is used. 6 Conclusions We number our main conclusions so as to facilitate a possible discussion: 1. There is a rough agreement, at least in the order of magnitude, between the subjective valuations of personal data and the earnings of large inter- net companies that monetize these data. For example, Facebook users might estimate the value of the service they receive, which is balanced by submitting their personal data, at a few dollars per month. On the other hand, today's annual average revenue per user (ARPU) for Facebook is equal to about $20. A superficial conclusion that could be drawn from the previous point might be that Facebook could perhaps produce more revenue by adopting a subscription model. However, it is rather obvious that a large part of its members would quit, thereby seriously damaging the network externalities on which Facebook is based. 2. The market capitalization of Facebook, Google, and similar companies, together with the fact that they are not capital intensive, point towards a value of more than $100 per user, which however should be seen as accumulated over the time period of the existence of the company. Thus this amount is in rough agreement with the previous figures. 3. There is a complex data collecting system of companies and organizations, which is full of intentional and unintentional holes, as also shown by the existence of a data brokerage market. The end result of this evolution is that everybody's personal data will soon become common knowledge, at least among service providers, ending up with zero value. This tendency is reinforced by advances in data mining and reasoning, a glimpse of which appears in Kosinski's work [KSG13, YKS15]. 4. Social media and search machine service providers have so far had a spe- cial relationship with personal data in both collection and monetization, mainly through targeted advertising. However, in view of the dropping value of the (less volatile part of the) personal data, this sector is likely to (a) enhance its role as a value extractor in the area of advertising, but also by expanding towards other areas (e.g. politics), (b) focus on the ex- traction and exploitation of dynamic data ("where is John Doe, and what is he doing now?"), and (c) control the dissemination of dynamic personal data, which will retain their value for a limited amount of time. 5. Needless to say, in this environment the average service user is not only less capable of protecting his or her own data, but also less likely to receive any compensation. 6. Any compensations (in the form of free services or payments) are not likely to be designed to cover probable damage from future data leakage and 11 illegal exploitation. It is very difficult to predict the costs of such damages. This fact might create new opportunities for insurance companies. References [AH17] Berit Anderson and Brett Horvath. The rise of the weaponized ai propaganda machine. Scout, February, 12, 2017. [Bak] [Bal] Dillon Baker. The 6 most important social media trends of 2017. [Online; accessed 22-June-2017]. Anita Balakrishnan. Facebook made about usd 4.23 off your profile in the first three months of the year. [Online; accessed 21-June- 2017]. [BKP12] Alastair R Beresford, Dorothea Kubler, and Soren Preibusch. Un- willingness to pay for privacy: A field experiment. Economics Let- ters, 117(1):25 -- 27, 2012. [BS03] [BSC17] [Buy] [CPN] Alastair R Beresford and Frank Stajano. Location privacy in perva- sive computing. IEEE Pervasive computing, 2(1):46 -- 55, 2003. Lemi Baruh, Ekin Secinti, and Zeynep Cemalcilar. Online privacy concerns and privacy management: A meta-analytical review. Jour- nal of Communication, 67(1):26 -- 53, 2017. Media Buying. Facebook mobile ad revenues to near $30 billion next year. [Online; accessed 22-June-2017]. Tomas Chamorro-Premuzic and Nathalie Nahai. Why we?re so hyp- ocritical about online privacy. [Online; accessed 8-September-2017]. [CRE+13] Juan Pablo Carrascal, Christopher Riederer, Vijay Erramilli, Mauro Cherubini, and Rodrigo de Oliveira. Your browsing behavior for a big mac: Economics of personal information online. In Proceedings of the 22nd international conference on World Wide Web, pages 189 -- 200. ACM, 2013. [Dat15] [Dia13] [eco] Data Center Knowledge. The facebook data center faq, 2015. [On- line; accessed 14-June-2017]. Jared Diamond. The world until yesterday: What can we learn from traditional societies? Penguin, 2013. Cisco adapts to the rise of cloud computing. The Economist. [Online; accessed 4-July-2017]. [EHDM08] Albrecht Enders, Harald Hungenberg, Hans-Peter Denker, and Se- bastian Mauch. The long tail of social networking.: Revenue models of social networking sites. European Management Journal, 26(3):199 -- 211, 2008. 12 [Fou11] [ftc14] [Fuc12] [GK17] [Kal17] Marion Fourcade. Price and prejudice: on economics, and the en- chantment/disenchantment of nature. The Worth of Goods, pages 41 -- 62, 2011. Data brokers: A call for transparency and accountability. Technical report, Federal Trade Commission, 05 2014. Christian Fuchs. The political economy of privacy on facebook. Tele- vision & New Media, 13(2):139 -- 159, 2012. Hannes Grassegger and Mikael Krogerus. The data that turned the world upside down, 2017. Pete Kallas. Top 15 most popular social networking sites and apps, 6 2017. [Online; accessed 15-June-2017]. [KSG13] Michal Kosinski, David Stillwell, and Thore Graepel. Private traits and attributes are predictable from digital records of human behav- ior. Proceedings of the National Academy of Sciences, 110(15):5802 -- 5805, 2013. [Lan16] [Pas14] Carl Landwehr. Privacy research directions. Commun. ACM, 59(2):29 -- 31, January 2016. Frank Pasquale. The dark market for personal data. The New York Times, 16:10 -- 14, 2014. [Ram17] Sridhar Ramaswamy. Building a better web for everyone, 2017. [Sta17] [SV98] [Tav11] [Var02] [WB90] Statista. Number of monthly active facebook users worldwide as of 1st quarter 2017 (in millions), 2017. [Online; accessed 14-June-2017]. Carl Shapiro and Hal R Varian. Information rules: a strategic guide to the network economy. Harvard Business Press, 1998. Herman T Tavani. Ethics and technology: Controversies, questions, and strategies for ethical computing. John Wiley & Sons, 2011. Hal R Varian. Economic aspects of personal privacy. In Cyber Policy and Economics in an Internet Age, pages 127 -- 137. Springer, 2002. Samuel D Warren and Louis D Brandeis. The right to privacy. Har- vard law review, pages 193 -- 220, 1890. [YKS15] Wu Youyou, Michal Kosinski, and David Stillwell. Computer- based personality judgments are more accurate than those made by humans. Proceedings of the National Academy of Sciences, 112(4):1036 -- 1040, 2015. 13
1601.03316
1
1601
2016-01-13T17:11:16
Additive Approximation Algorithms for Modularity Maximization
[ "cs.SI", "cs.DS", "physics.soc-ph" ]
The modularity is a quality function in community detection, which was introduced by Newman and Girvan (2004). Community detection in graphs is now often conducted through modularity maximization: given an undirected graph $G=(V,E)$, we are asked to find a partition $\mathcal{C}$ of $V$ that maximizes the modularity. Although numerous algorithms have been developed to date, most of them have no theoretical approximation guarantee. Recently, to overcome this issue, the design of modularity maximization algorithms with provable approximation guarantees has attracted significant attention in the computer science community. In this study, we further investigate the approximability of modularity maximization. More specifically, we propose a polynomial-time $\left(\cos\left(\frac{3-\sqrt{5}}{4}\pi\right) - \frac{1+\sqrt{5}}{8}\right)$-additive approximation algorithm for the modularity maximization problem. Note here that $\cos\left(\frac{3-\sqrt{5}}{4}\pi\right) - \frac{1+\sqrt{5}}{8} < 0.42084$ holds. This improves the current best additive approximation error of $0.4672$, which was recently provided by Dinh, Li, and Thai (2015). Interestingly, our analysis also demonstrates that the proposed algorithm obtains a nearly-optimal solution for any instance with a very high modularity value. Moreover, we propose a polynomial-time $0.16598$-additive approximation algorithm for the maximum modularity cut problem. It should be noted that this is the first non-trivial approximability result for the problem. Finally, we demonstrate that our approximation algorithm can be extended to some related problems.
cs.SI
cs
Additive Approximation Algorithms for Modularity Maximization Yasushi Kawase∗, Tomomi Matsui†, and Atsushi Miyauchi‡ Graduate School of Decision Science and Technology, Tokyo Institute of Technology, Ookayama 2-12-1, Meguro-ku, Tokyo 152-8552, Japan January 14, 2016 Abstract The modularity is a quality function in community detection, which was introduced by Newman and Girvan (2004). Community detection in graphs is now often conducted through modularity maximization: given an undirected graph G = (V, E), we are asked to find a parti- tion C of V that maximizes the modularity. Although numerous algorithms have been developed to date, most of them have no theoretical approximation guarantee. Recently, to overcome this issue, the design of modularity maximization algorithms with provable approximation guaran- tees has attracted significant attention in the computer science community. In this study, we further investigate the approximability of modularity maximization. More -additive approximation al- specifically, we propose a polynomial-time cos (cid:17) (cid:16) (cid:16) 3−√5 4 π (cid:17) − 1+√5 8 (cid:16) 3−√5 (cid:17) − 1+√5 gorithm for the modularity maximization problem. Note here that cos 8 < 0.42084 holds. This improves the current best additive approximation error of 0.4672, which was recently provided by Dinh, Li, and Thai (2015). Interestingly, our analysis also demon- strates that the proposed algorithm obtains a nearly-optimal solution for any instance with a very high modularity value. Moreover, we propose a polynomial-time 0.16598-additive approx- imation algorithm for the maximum modularity cut problem. It should be noted that this is the first non-trivial approximability result for the problem. Finally, we demonstrate that our approximation algorithm can be extended to some related problems. 4 π 1 Introduction Identifying community structure is a fundamental primitive in graph mining [16]. Roughly speak- ing, a community (also referred to as a cluster or module) in a graph is a subset of vertices densely connected with each other, but sparsely connected with the vertices outside the subset. Commu- nity detection in graphs is a powerful way to discover components that have some special roles or possess important functions. For example, consider the graph representing the World Wide Web, where vertices correspond to web pages and edges represent hyperlinks between pages. Communi- ties in this graph are likely to be the sets of web pages dealing with the same or similar topics, or sometimes link spam [19]. As another example, consider the protein–protein interaction graphs, where vertices correspond to proteins within a cell and edges represent interactions between pro- teins. Communities in this graph are likely to be the sets of proteins that have the same or similar functions within the cell [31]. ∗email: [email protected] †email: [email protected] ‡email: [email protected] (Corresponding author) 1 To date, numerous community detection algorithms have been developed, most of which are designed to maximize a quality function. Quality functions in community detection return some value that represents the community-degree for a given partition of the set of vertices. The best known and widely used quality function is the modularity, which was introduced by Newman and Girvan [29]. Let G = (V, E) be an undirected graph consisting of n = V vertices and m = E i=1 Ci = V and Ci ∩ Cj = ∅ for i (cid:54)= j), can be written as edges. The modularity, a quality function for a partition C = {C1, . . . , Ck} of V (i.e.,(cid:83)k Q(C) = mC m − (cid:32) (cid:88) C∈C (cid:19)2(cid:33) , (cid:18) DC 2m where mC represents the number of edges whose endpoints are both in C, and DC represents the sum of degrees of the vertices in C. The modularity represents the sum, over all communities, of the fraction of the number of edges within communities minus the expected fraction of such edges assuming that they are placed at random with the same degree distribution. The modularity is based on the idea that the greater the above surplus, the more community-like the partition C. Although the modularity is known to have some drawbacks (e.g., the resolution limit [17] and degeneracies [21]), community detection is now often conducted through modularity maximization: given an undirected graph G = (V, E), we are asked to find a partition C of V that maximizes the modularity. Note that the modularity maximization problem has no restriction on the number of communities in the output partition; thus, the algorithms are allowed to specify the best number of communities by themselves. Brandes et al. [6] proved that modularity maximization is NP-hard. This implies that unless P = NP, there exists no polynomial-time algorithm that finds a partition with maximum modularity for any instance. A wide variety of applications (and this hardness result) have promoted the development of modularity maximization heuristics. In fact, there are numerous algorithms based on various techniques such as greedy procedure [5, 11, 29], simulated annealing [22, 24], spectral optimization [28, 30], extremal optimization [15], and mathematical programming [1, 7, 8, 25]. Although some of them are known to perform well in practice, they have no theoretical approximation guarantee at all. Recently, to overcome this issue, the design of modularity maximization algorithms with prov- able approximation guarantees has attracted significant attention in the computer science commu- nity. DasGupta and Desai [12] designed a polynomial-time -additive approximation algorithm1 for dense graphs (i.e., graphs with m = Ω(n2)) using an algorithmic version of the regularity lemma [18], where  > 0 is an arbitrary constant. Moreover, Dinh, Li, and Thai [13] very re- cently developed a polynomial-time 0.4672-additive approximation algorithm. This is the first polynomial-time additive approximation algorithm with a non-trivial approximation guarantee for modularity maximization (that is applicable to any instance).2 Note that, to our knowledge, this is the current best additive approximation error. Their algorithm is based on the semidefinite programming (SDP) relaxation and the hyperplane separation technique. 1.1 Our Contribution In this study, we further investigate the approximability of modularity maximization. Our contri- bution can be summarized as follows: 1 A feasible solution is α-additive approximate if its objective value is at least the optimal value minus α. An algorithm is called an α-additive approximation algorithm if it returns an α-additive approximate solution for any instance. For an α-additive approximation algorithm, α is referred to as an additive approximation error of the algorithm. 2 A 1-additive approximation algorithm is trivial because Q({V }) = 0 and Q(C) < 1 for any partition C. 2 (cid:16) (cid:16) 3−√ 5 4 π (cid:17) (cid:16) 3−√ (cid:17) (cid:17) √ − 1+ 8 5 1. We propose a polynomial-time cos √ − 1+ the modularity maximization problem. Note here that cos 8 < 0.42084 holds; thus, this improves the current best additive approximation error of 0.4672, which was re- cently provided by Dinh, Li, and Thai [13]. Interestingly, our analysis also demonstrates that the proposed algorithm obtains a nearly-optimal solution for any instance with a very high modularity value. 4 π 5 5 -additive approximation algorithm for 2. We propose a polynomial-time 0.16598-additive approximation algorithm for the maximum modularity cut problem. It should be noted that this is the first non-trivial approximability result for the problem. 3. We demonstrate that our additive approximation algorithm for the modularity maximization problem can be extended to some related problems. First result. Let us describe our first result in details. Our additive approximation algorithm is also based on the SDP relaxation and the hyperplane separation technique. However, as described below, our algorithm is essentially different from the one proposed by Dinh, Li, and Thai [13]. The algorithm by Dinh, Li, and Thai [13] reduces the SDP relaxation for the modularity maximization problem to the one for MaxAgree problem arising in correlation clustering (e.g., see [3] or [9]) by adding an appropriate constant to the objective function. Then, the algorithm adopts the SDP-based 0.7664-approximation algorithm3 for MaxAgree problem, which was developed by Charikar, Guruswami, and Wirth [9]. In fact, the additive approximation error of 0.4672 is just derived from 2(1− κ), where κ represents the approximation ratio of the SDP-based algorithm for MaxAgree problem (i.e., κ = 0.7664). It should be noted that the analysis of the SDP-based algorithm for MaxAgree problem [9] aims at multiplicative approximation rather than additive one. As a result, the analysis by Dinh, Li, and Thai [13] has caused a gap in terms of additive approximation. In contrast, our algorithm does not depend on such a reduction. In fact, our algorithm just solves the SDP relaxation for the modularity maximization problem without any transformation. Moreover, our algorithm employs a hyperplane separation procedure different from the one used in their algorithm. The algorithm by Dinh, Li, and Thai [13] generates 2 and 3 random hyperplanes to obtain feasible solutions, and then returns the better one. On the other hand, our algorithm chooses an appropriate number of hyperplanes using the information of the optimal solution to the SDP relaxation so that the lower bound on the expected modularity value is maximized. Note here that this modification does not improve the worst-case performance of the algorithm by Dinh, Li, and Thai [13]. In fact, as shown in our analysis, their algorithm already has the additive approximation error of cos . However, we demonstrate that the proposed algorithm has a much better lower bound on the expected modularity value for many instances. In particular, for any instance with optimal value close to 1 (a trivial upper bound), our algorithm obtains a nearly-optimal solution. At the end of our analysis, we summarize a lower bound on the expected modularity value with respect to the optimal value of a given instance. (cid:16) 3−√ √ − 1+ 4 π (cid:17) 8 5 5 Second result. Here we describe our second result in details. The modularity maximization problem has no restriction on the number of clusters in the output partition. On the other hand, there also exist a number of problem variants with such a restriction. The maximum modularity 3 A feasible solution is α-approximate if its objective value is at least α times the optimal value. An algorithm is called an α-approximation algorithm if it returns an α-approximate solution for any instance. For an α-approximation algorithm, α is referred to as an approximation ratio of the algorithm. 3 cut problem is a typical one, where given an undirected graph G = (V, E), we are asked to find a partition C of V consisting of at most two components (i.e., a bipartition C of V ) that maximizes the modularity. This problem appears in many contexts in community detection. For example, a few hierarchical divisive heuristics for the modularity maximization problem repeatedly solve this problem either exactly [7, 8] or heuristically [1], to obtain a partition C of V . Brandes et al. [6] proved that the maximum modularity cut problem is NP-hard (even on dense graphs). More recently, DasGupta and Desai [12] showed that the problem is NP-hard even on d-regular graphs with any fixed d ≥ 9. However, to our knowledge, there exists no approximability result for the problem. Our additive approximation algorithm adopts the SDP relaxation and the hyperplane separa- tion technique, which is identical to the subroutine of the hierarchical divisive heuristic proposed by Agarwal and Kempe [1]. Specifically, our algorithm first solves the SDP relaxation for the maximum modularity cut problem (rather than the modularity maximization problem), and then generates a random hyperplane to obtain a feasible solution for the problem. Although the com- putational experiments by Agarwal and Kempe [1] demonstrate that their hierarchical divisive heuristic maximizes the modularity quite well in practice, the approximation guarantee of the sub- routine in terms of the maximum modularity cut was not analyzed. Our analysis shows that the proposed algorithm is a 0.16598-additive approximation algorithm for the maximum modularity cut problem. At the end of our analysis, we again present a lower bound on the expected modular- ity value with respect to the optimal value of a given instance. This reveals that for any instance with optimal value close to 1/2 (a trivial upper bound in the case of bipartition), our algorithm obtains a nearly-optimal solution. Third result. Finally, we describe our third result. In addition to the above problem vari- ants with a bounded number of clusters, there are many other variations of modularity maxi- mization [16]. We demonstrate that our additive approximation algorithm for the modularity maximization problem can be extended to the following three problems: the weighted modular- ity maximization problem [27], the directed modularity maximization problem [23], and Barber’s bipartite modularity maximization problem [4]. 1.2 Related Work SDP relaxation. The seminal work by Goemans and Williamson [20] has opened the door to the design of approximation algorithms using the SDP relaxation and the hyperplane separation technique. To date, this approach has succeeded in developing approximation algorithms for various NP-hard problems [32]. As mentioned above, Agarwal and Kempe [1] introduced the SDP relaxation for the maximum modularity cut problem. For the original modularity maximization problem, the SDP relaxation was recently used by Dinh, Li, and Thai [13]. Multiplicative approximation algorithms. As mentioned above, the design of approximation algorithms for modularity maximization has recently become an active research area in the com- puter science community. Indeed, in addition to the additive approximation algorithms described above, there also exist multiplicative approximation algorithms. DasGupta and Desai [12] designed an Ω(1/ log d)-approximation algorithm for d-regular graphs with d ≤ n 2 log n . Moreover, they developed an approximation algorithm for the weighted modularity maximization problem. The approximation ratio is logarithmic in the maximum weighted degree of edge-weighted graphs (where the edge-weights are normalized so that the sum of weights are equal to the number of edges). This algorithm requires that the maximum weighted degree is 5√ log n . These algorithms are not derived directly from logarithmic approximation less than about n 4 algorithms for quadratic forms (e.g., see [2] or [10]) because the quadratic form for modularity maximization has negative diagonal entries. To overcome this difficulty, they designed a more specialized algorithm using a graph decomposition technique. (cid:17) (cid:16) ζ(γ) Dinh and Thai [14] developed multiplicative approximation algorithms for the modularity max- imization problem on scale-free graphs with a prescribed degree sequence. In their graphs, the number of vertices with degree d is fixed to some value proportional to d−γ, where −γ is called -approximation algorithm for an arbitrarily small  > 0, where ζ(γ) =(cid:80)∞ the power-law exponent. For such scale-free graphs with γ > 2, they developed a polynomial- 1 time iγ is the Riemann zeta function. For graphs with 1 < γ ≤ 2, they developed a polynomial-time Ω(1/ log n)-approximation algorithm using the logarithmic approximation algorithm for quadratic forms [10]. ζ(γ−1) −  i=1 Inapproximability results. There are some inapproximability results for the modularity max- imization problem. DasGupta and Desai [12] showed that it is NP-hard to obtain a (1 − )- approximate solution for some constant  > 0 (even for complements of 3-regular graphs). More recently, Dinh, Li, and Thai [13] proved a much stronger statement, that is, there exists no polynomial-time (1 − )-approximation algorithm for any  > 0, unless P = NP. It should be noted that these results are on multiplicative approximation rather than additive one. In fact, there exist no inapproximability results in terms of additive approximation for modularity maxi- mization. 1.3 Preliminaries Here we introduce definitions and notation used in this paper. Let G = (V, E) be an undirected graph consisting of n = V vertices and m = E edges. Let P = V × V . By simple calculation, as mentioned in Brandes et al. [6], the modularity can be rewritten as (cid:18) (cid:88) (i,j)∈P (cid:19) Q(C) = 1 2m Aij − didj 2m δ(C(i),C(j)), where Aij is the (i, j) component of the adjacency matrix A of G, di is the degree of i ∈ V , C(i) is the (unique) community to which i ∈ V belongs, and δ represents the Kronecker symbol equal to 1 if two arguments are identical and 0 otherwise. This form is useful to write mathematical programming formulations for modularity maximization. For convenience, we define qij = Aij 2m − didj 4m2 for each (i, j) ∈ P. We can divide the set P into the following two disjoint subsets: Clearly, we have and thus P≥0 = {(i, j) ∈ P qij ≥ 0} (cid:88) (cid:88) and P<0 = {(i, j) ∈ P qij < 0}. (cid:88) qij = 0, (i,j)∈P≥0 (i,j)∈P<0 (i,j)∈P qij + (cid:88) qij = (cid:88) 5 qij = −qij. (i,j)∈P<0 (i,j)∈P≥0 Maximize qij (yi · yj) subject to yi ∈ {e1, . . . , en} (∀i ∈ V ), (cid:88) (i,j)∈P (cid:88) where ek (1 ≤ k ≤ n) represents the vector that has 1 in the kth coordinate and 0 elsewhere. We denote by OPT the optimal value of this original problem. Note that for any instance, we have OPT ∈ [0, 1). We introduce the following semidefinite relaxation problem: We denote this value by q, i.e., (cid:88) (i,j)∈P≥0 qij. q = Note that for any instance, we have q < 1. 1.4 Paper Organization This paper is structured as follows. In Section 2, we revisit the SDP relaxation for the modu- larity maximization problem, and then describe an outline of our algorithm. In Section 3, the approximation guarantee of the proposed algorithm is carefully analyzed. In Section 4, we propose an additive approximation algorithm for the maximum modularity cut problem. We extend our additive approximation algorithm to some related problems in Section 5. Finally, conclusions and future work are presented in Section 6. 2 Algorithm In this section, we revisit the SDP relaxation for the modularity maximization problem, and then describe an outline of our algorithm. The modularity maximization problem can be formulated as follows: SDP : Maximize qijxij (i,j)∈P subject to xii = 1 xij ≥ 0 X = (xij) ∈ S n +, (∀i ∈ V ), (∀i, j ∈ V ), + represents the cone of n × n symmetric positive semidefinite matrices. where S n It is easy to see that every feasible solution X = (xij) of SDP satisfies xij ≤ 1 for any (i, j) ∈ P . Although the algorithm by Dinh, Li, and Thai [13] reduces SDP to the one for MaxAgree problem by adding an appropriate constant to the objective function, our algorithm just solves SDP without any transformation. Let X∗ = (x∗ ij) be an optimal solution to SDP, which can be computed (with an arbitrarily small error) in time polynomial in n and m. Using the optimal solution X∗, we define the following two values: (cid:88) (i,j)∈P≥0 ∗ z + = 1 q ∗ ij qijx and z ∗ − = 1 q (cid:88) (i,j)∈P<0 ∗ ij, qijx both of which are useful in the analysis of the approximation guarantee of our algorithm. Clearly, we have 0 ≤ z∗ + ≤ 1 and −1 ≤ z∗− ≤ 0. 6 Algorithm 1 Hyperplane(k) Input: Graph G = (V, E) Output: Partition C of V 1: Obtain an optimal solution X∗ = (x∗ 2: Generate k random hyperplanes and obtain a partition Ck = {C1, . . . , C2k} of V 3: return Ck ij) to SDP We apply the hyperplane separation technique to obtain a feasible solution of the modular- ity maximization problem. Specifically, we consider the following general procedure: generate k random hyperplanes to separate the vectors corresponding to the optimal solution X∗, and then obtain a partition Ck = {C1, . . . , C2k} of V . For reference, the procedure is described in Algo- rithm 1. Note here that at this time, we have not yet mentioned how to determine the number k of hyperplanes we generate. As revealed in our analysis, we can choose an appropriate number of hyperplanes using the value of z∗ + so that the lower bound on the expected modularity value of the output of Hyperplane(k) is maximized. 3 Analysis In this section, we first analyze an additive approximation error of Hyperplane(k) for each positive integer k ∈ Z>0. Then, we provide an appropriate number k∗ which completes the design of our algorithm. Finally, we present a lower bound on the expected modularity value of the output of Hyperplane(k∗) with respect to the value of OPT. ∈ Z>0 of hyperplanes we generate, When k random hyperplanes are generated independently, the probability that two vertices i, j ∈ V are in the same cluster is given by(cid:18) as mentioned in previous works (e.g., see [9] or [20]). For simplicity, we define the function (cid:19)k , (cid:19)k arccos(x∗ ij) π 1 − (cid:18) fk(x) = 1 − arccos(x) π for x ∈ [0, 1]. Here we present the lower convex envelope of each of fk(x) and −fk(x). Lemma 1. For any positive integer k, the lower convex envelope of fk(x) is given by fk(x) itself, and the lower convex envelope of −fk(x) is given by the linear function hk(x) = −1/2k +(1/2k−1)x for x ∈ [0, 1]. The following lemma lower bounds the expected modularity value of the output of Hyper- plane(k). Lemma 2. Let Ck be the output of Hyperplane(k). For any positive integer k, it holds that E[Q(Ck)] ≥ q(cid:0)fk(z ∗ +) + hk(−z −)(cid:1) . ∗ Proof. Recall that Ck(i) for each i ∈ V denotes the (unique) cluster in Ck that includes the vertex i. Note here that δ(Ck(i),Ck(j)) for each (i, j) ∈ P is a random variable, which takes 1 with 7 probability fk(x∗ as follows: ij) and 0 with probability 1 − fk(x∗ ij). The expectation E[Q(Ck)] is lower bounded E[Q(Ck)] = E qijδ(Ck(i),Ck(j))  = = ∗ ij) (i,j)∈P (i,j)∈P qijfk(x qijfk(x (i,j)∈P≥0  (cid:88) (cid:88) (cid:88) (cid:88)  (cid:88) (cid:18) qij  (cid:88) fk = q(cid:0)fk(z (i,j)∈P≥0 (i,j)∈P≥0 qijfk(x ≥ q = q ≥ q (i,j)∈P≥0 ∗ +) + hk(−z ∗ ij) + ∗ ij) + fk(x (cid:19) (cid:18) qij (cid:19) −)(cid:1) , q ∗ (cid:88) (cid:88) (i,j)∈P<0 (i,j)∈P<0 −qij · (−fk(x ∗ ij)) ∗ ij) −qijhk(x (cid:18) (cid:88)  (cid:88)  + hk (i,j)∈P<0 −qij q (cid:19) (cid:18) (i,j)∈P<0 ∗ ij) + ∗ ij x  ∗ ij) (cid:19) hk(x −qij q ∗ ij x  where the last inequality follows from Jensen’s inequality. The following lemma provides an additive approximation error of Hyperplane(k) by evaluating the above lower bound on E[Q(Ck)] using the value of OPT. Lemma 3. For any positive integer k, it holds that Proof. Clearly, (z∗ +, z∗−) satisfies q(z∗ q(cid:0)fk(z −)(cid:1) ∗ ∗ +) + hk(−z E[Q(Ck)] ≥ OPT − q ≥ (cid:0)OPT − q(z + + z∗−) ≥ OPT and z∗− ≤ 0. Thus, we obtain =(cid:0)OPT − q(z (cid:16) (cid:16) ∗ +) + 1/2k + (1/2k)z ∗ ∗ +) + hk(−z ∗ +) − 1/2k + (1/2k − 1)(−z −)(cid:1) (cid:17) ∗ − ∗ z ∗ ∗ ∗ + + z ∗ + + z ∗ + − fk(z ∗ + − fk(z z . (cid:17) ∗ −) (cid:19) . 1 2k ∗ +) + ∗ + − fk(z z (cid:18) −)(cid:1) + q(cid:0)fk(z (cid:16) −)(cid:1) + q +) + 1/2k(cid:17) (cid:18) fk(z ≥ OPT − q (cid:19) , ∗ +) + 1 2k ∗ + − fk(z z = OPT − q ≥ OPT − q Combining this with Lemma 2, we have E[Q(Ck)] ≥ q(cid:0)fk(z ∗ +) + hk(−z −)(cid:1) ∗ as desired. For simplicity, we define the function gk(x) = x − fk(x) + 1 2k 8 Figure 1: A brief illustration of the additive approximation error of Hyperplane(k) with respect (cid:16) to the value of z∗ +. For simplicity, we replace q by its upper bound 1. Specifically, the function gk(x) = x − fk(x) + 1/2k for x ∈ [0, 1] is plotted for k = 1, 2, 3, 4, and 5, as examples. The point cos is an intersection of the functions g2(x) and g3(x). (cid:16) 3−√ (cid:16) 3−√ (cid:17) (cid:17) (cid:17) , cos 5 4 π 5 4 π √ − 1+ 8 5 for x ∈ [0, 1]. Then, the inequality of the above lemma can be rewritten as E[Q(Ck)] ≥ OPT − q · gk(z ∗ +). Figure 1 plots the above additive approximation error of Hyperplane(k) with respect to the value of z∗ +. As can be seen, the appropriate number of hyperplanes (i.e., the number of hyperplanes that minimizes the additive approximation error) depends on the value of z∗ +. Intuitively, we wish to choose k∗∗ that satisfies ∗∗ k ∈ arg min k∈Z>0 ∗ +). gk(z However, it is not clear whether Hyperplane(k∗∗) runs in polynomial time. In fact, the number k∗∗ becomes infinity if the value of z∗ + approaches 1. Therefore, alternatively, our algorithm chooses ∗ k ∈ arg min k∈{1,...,max{3,(cid:100)log2 n(cid:101)}} ∗ +). gk(z Our analysis demonstrates that the worst-case performance of Hyperplane(k∗) is exactly the same as that of Hyperplane(k∗∗), and moreover, the lower bound on the expected modularity value with respect to the value of OPT is not affected by this change. The following lemma analyzes the worst-case performance of Hyperplane(k∗); thus, it provides the additive approximation error of Hyperplane(k∗). Lemma 4. It holds that max x∈[0,1] k∈{1,...,max{3,(cid:100)log2 n(cid:101)}} gk(x) = cos min 9 (cid:32) (cid:33) 3 − √5 4 π 1 + √5 8 . − 00.20.40.60.8100.20.40.6←cos(3−√54π)−1+√58cos(3−√54π)↓z∗+Additiveapproximationerrork=1k=2k=3k=4k=5 Proof. First, we show that (cid:32) max x∈[0,1] k∈{1,...,max{3,(cid:100)log2 n(cid:101)}} gk(x) ≥ cos min (cid:33) π − 1 + √5 . 4 3 − √5 (cid:33) (cid:32) 3 − √5 4 π − 1 + √5 ≥ cos 8 . π 4 g1 gk cos cos (cid:32) For k = 1, 2, 3, and 4, we have It suffices to show that for any k ∈ Z>0, 3 − √5 (cid:32) (cid:32) (cid:32) (cid:32) 3 − √5 3 − √5 3 − √5 (cid:32) (cid:33)(cid:33) (cid:33)(cid:33) (cid:33)(cid:33) (cid:33)(cid:33) (cid:32) (cid:32) (cid:32) (cid:32) (cid:32) (cid:32) (cid:32) (cid:32) − cos − cos − cos and cos cos g3 g2 π π π 4 4 4 4 3 − √5 3 − √5 3 − √5 4 π (cid:33)(cid:33) (cid:33) (cid:33) (cid:33) (cid:33) π π 4 g4 cos π − cos 4 3 − √5 (cid:32) 3 − √5 4 (cid:33)(cid:33) (cid:32) respectively. For k ≥ 5, we have π 4 3 − √5 (cid:32) 3 − √5 4 + (cid:33) gk cos π − cos π + (cid:32) Thus, for any k ∈ Z>0, we obtain (cid:32) gk cos Next, we show that (cid:33)(cid:33) (cid:32) π ≥ cos 3 − √5 4 max x∈[0,1] k∈{1,...,max{3,(cid:100)log2 n(cid:101)}} gk(x) ≤ cos min By simple calculation, we get 1 + √5 8 1 + √5 8 1 + √5 8 + + + = = = 1 + √5 8 1 + √5 8 1 + √5 8 − − − 1 + √5 1 + √5 1 + √5 4 4 4 + 1 2 > 0, + + 1 4 1 8 = 0, = 0, 8 (cid:32) (cid:32) (cid:32) (cid:32) (cid:33) (cid:33)2 (cid:33)3 (cid:33)4 1 + √5 8 = 1 + √5 8 − 1 + √5 8 = > 1 + √5 8 1 + √5 1 + √5 4 (cid:32) (cid:32) − − 1 + √5 4 1 + √5 4 + (cid:33)k (cid:33)5 8 (cid:33) π − 4 3 − √5 (cid:32) 1 + √5 . 8 (cid:33) π − 3 − √5 4 1 + √5 8 . 1 16 > 0, + 1 2k > 0. . (cid:48) 2(x) = 1 − g 2(1 − arccos(x)/π) π√1 − x2 (cid:32) (cid:32) Let us take an arbitrary x with 0 ≤ x ≤ cos 3 − √5 cos g2(x) ≤ g2 4 and g (cid:16) 3−√ (cid:33)(cid:33) 5 4 π (cid:17) (cid:48) 3(x) = 1 − . Since g(cid:48) 3 − √5 (cid:32) π√1 − x2 3(1 − arccos(x)/π)2 (cid:33) 2(x) > 0, we have 1 + √5 π . π = cos 4 − 8 10 On the other hand, take x with cos g3(x) ≤ g3 Note finally that g3(1) < cos (cid:17) π 5 4 π (cid:16) 3−√ (cid:32) 3 − √5 (cid:17) 4 √ − 1+ 8 5 (cid:32) (cid:16) 3−√ cos 5 4 π ≤ x < 1. Since g(cid:48) (cid:33)(cid:33) 3 − √5 (cid:32) = cos (cid:33) 3(x) < 0, we have 1 + √5 . π − 4 8 holds. Therefore, we obtain max x∈[0,1] k∈{1,...,max{3,(cid:100)log2 n(cid:101)}} gk(x) ≤ max x∈[0,1] min k∈{2,3} gk(x) ≤ cos min as desired. Remark 1. From the proof of the above lemma, it follows directly that 1 + √5 3 − √5 π 4 − . 8 max x∈[0,1] min k∈Z>0 gk(x) = cos (cid:32) (cid:33) 1 + √5 8 , − 3 − √5 4 π (cid:32) (cid:32) (cid:33) (cid:33) This implies that the worst-case performance of Hyperplane(k∗∗) is no better than that of Hyper- plane(k∗). Remark 2. Here we consider the algorithm that executes Hyperplane(2) and Hyperplane(3), and then returns the better solution. Note that this algorithm is essentially the same as that proposed by Dinh, Li, and Thai [13]. From the proof of the above lemma, it follows immediately that max x∈[0,1] min k∈{2,3} gk(x) = cos 3 − √5 4 π 1 + √5 8 . − This implies that the algorithm by Dinh, Li, and Thai [13] already has the worst-case performance exactly the same as that of Hyperplane(k∗). However, as shown below, Hyperplane(k∗) has a much better lower bound on the expected modularity value for many instances. Finally, we present a lower bound on the expected modularity value of the output of Hyper- plane(k∗) with respect to the value of OPT (rather than z∗ +). The following lemma is useful to show that the lower bound on the expected modularity value with respect to the value of OPT is not affected by the change from k∗∗ to k∗. The proof can be found in Appendix A. Lemma 5. For any k(cid:48) ≤ max{3,(cid:100)log2 n(cid:101)}. We are now ready to prove the following theorem. Theorem 1. Let Ck∗ be the output of Hyperplane(k∗). It holds that ∈ arg mink∈Z>0 gk(OPT), it holds that k(cid:48) (cid:33) (cid:32) (cid:32) E[Q(Ck∗)] ≥ OPT − q cos (cid:33) . 3 − √5 4 1 + √5 π − 8 In particular, if OPT ≥ cos holds, then Note here that q < 1 and cos (cid:17) 5 4 π (cid:16) 3−√ (cid:16) 3−√ 5 4 π (cid:17) E[Q(Ck∗)] > OPT − q min k∈Z>0 gk(OPT). √ − 1+ 8 < 0.42084. 5 11 Proof. From Lemmas 3 and 4, it follows directly that (cid:32) (cid:32) (cid:33) (cid:33) . 1 + √5 8 − 3 − √5 4 π E[Q(Ck∗)] ≥ OPT − q cos (cid:17) holds. 5 4 π (cid:16) 3−√ (cid:17) , Here we prove the remaining part of the theorem. Assume that OPT ≥ cos By simple calculation, for any k ∈ Z>0, we have k(1 − arccos(x)/π)k−2(cid:16) g (cid:48)(cid:48) k(x) = − (k − 1)√1 − x2 + πx (1 − arccos(x)/π) π2(1 − x2)3/2 (cid:17) all of which are negative for x ∈ (0, 1). This means that for any k ∈ Z>0, the function gk(x) is strictly concave, and moreover, so is the function mink∈{1,...,max{3,(cid:100)log2 n(cid:101)}} gk(x). From the proof of Lemma 4, the function mink∈{1,...,max{3,(cid:100)log2 n(cid:101)}} gk(x) attains its maximum (i.e., cos − 1+ . Thus, the function mink∈{1,...,max{3,(cid:100)log2 n(cid:101)}} gk(x) is strictly monoton- 8 (cid:16) 3−√ (cid:16) 3−√ ) at x = cos 4 π 4 π (cid:17) √ 5 5 5 (cid:104) (cid:16) 3−√ 5 4 π (cid:17) (cid:105) ically decreasing over the interval cos , 1 . Therefore, we have min E[Q(Ck∗)] ≥ OPT − q k∈{1,...,max{3,(cid:100)log2 n(cid:101)}} gk(z > OPT − q k∈{1,...,max{3,(cid:100)log2 n(cid:101)}} gk(OPT) = OPT − q min k∈Z>0 gk(OPT), min ∗ +) where the second inequality follows from z∗ Lemma 5. + ≥ OPT/q > OPT and the last equality follows from Figure 2 depicts the above lower bound on E[Q(Ck∗)]. As can be seen, if OPT is close to 1, then Hyperplane(k∗) obtains a nearly-optimal solution. For example, for any instance with OPT ≥ 0.99900, it holds that E[Q(Ck∗)] > 0.90193, i.e., the additive approximation error is less than 0.09807. Remark 3. The additive approximation error of Hyperplane(k∗) depends on the value of q < 1. We see that the less the value of q, the better the additive approximation error. Thus, it is interesting to find some graphs that have a small value of q. For instance, for any regular graph G that satisfies m = α 2 n2, it holds that q = 1 − α, where α is an arbitrary constant in (0, 1). Here we prove the statement. Since G is regular, we have di = 2m/n = αn for any i ∈ V . Moreover, for any {i, j} ∈ E, it holds that qij = Aij n2 > 0. Therefore, we have αn2 − 1 4m2 = 1 (cid:88) (i,j)∈P≥0 (cid:88) 2m − didj {i,j}∈E q = qij = 2 qij = 2m (cid:18) 1 (cid:19) αn2 − 1 n2 = 1 − α. 4 Maximum Modularity Cut In this section, we propose a polynomial-time 0.16598-additive approximation algorithm for the maximum modularity cut problem. 12 Figure 2: A brief illustration of the lower bound on the expected modularity value of the output of Hyperplane(k∗) with respect to the value of OPT. For simplicity, we replace q by its upper bound 1. Note that k(cid:48) ∈ arg mink∈Z>0 gk(OPT). 4.1 Algorithm In this subsection, we revisit the SDP relaxation for the maximum modularity cut problem, and then describe our algorithm. The maximum modularity cut problem can be formulated as follows: (cid:18) (cid:88) (i,j)∈P (cid:19) Maximize 1 4m Aij − didj 2m (yiyj + 1) subject to yi ∈ {−1, 1} (∀i ∈ V ). We denote by OPTcut the optimal value of this original problem. Note that for any instance, it holds that OPTcut ∈ [0, 1/2], as shown in DasGupta and Desai [12]. We introduce the following semidefinite relaxation problem: SDPcut : Maximize 1 4m Aij − didj 2m (xij + 1) (cid:18) (cid:88) (i,j)∈P (cid:19) subject to xii = 1 (∀i ∈ V ), X = (xij) ∈ S n +, where recall that S n + represents the cone of n × n symmetric positive semidefinite matrices. Let X∗ = (x∗ ij) be an optimal solution to SDPcut, which can be computed (with an arbitrarily small error) in time polynomial in n and m. Note here that x∗ ij may be negative for (i, j) ∈ P with i (cid:54)= j, unlike SDP in the previous section. The objective function value of X∗ can be divided into the following two terms: (cid:88) (i,j)∈P ∗ + = z 1 4m Aij(x ∗ ij + 1) and z ∗ − = − 1 8m2 13 (cid:88) (i,j)∈P didj(x ∗ ij + 1). 00.20.40.60.8100.20.40.60.81cos(3−√54π)−1+√58↓cos(3−√54π)↓OPTLowerboundonE[Q(Ck∗)]OPTtrivialk′=2k′=3k′=4k′=5k′=6k′=7 Algorithm 2 Modularity Cut Input: Graph G = (V, E) Output: Bipartition C of V 1: Obtain an optimal solution X∗ = (x∗ 2: Generate a random hyperplane and obtain a bipartition Cout = {C1, C2} of V 3: return Cout ij) to SDPcut We generate a random hyperplane to separate the vectors corresponding to the optimal solution X∗, and then obtain a bipartition C = {C1, C2} of V . For reference, the procedure is described in Algorithm 2. As mentioned above, this algorithm is identical to the subroutine of the hierarchical divisive heuristic for the modularity maximization problem, which was proposed by Agarwal and Kempe [1]. 4.2 Analysis In this subsection, we show that Algorithm 2 obtains a 0.16598-additive approximate solution for any instance. At the end of our analysis, we present a lower bound on the expected modularity value of the output of Algorithm 2 with respect to the value of OPTcut. We start with the following lemma. Lemma 6. It holds that 1/2 ≤ z∗ Proof. Clearly, z∗ + ≤ 1 and −1 ≤ z∗− ≤ −1/2. + ≤ 1 and z∗− ≥ −1. Since X∗ is positive semidefinite, we have (cid:88)  ≤ − (cid:0)0 + 4m2(cid:1) = − 1 2 . 1 8m2 1 ∗ − = − z Combining this with z∗ 8m2 didjx ∗ ij + didj (i,j)∈P (i,j)∈P + + z∗− ≥ OPTcut ≥ 0, we get  (cid:88) ∗ + ≥ OPTcut − z z ∗ − ≥ OPTcut + 1 2 ≥ 1 2 , as desired. 1 − arccos(x∗ In Algorithm 2, the probability that two vertices i, j ∈ V are in the same cluster is given by ij)/π. For simplicity, we define the following two functions (cid:18) (cid:19) p+(x) = 1 − arccos(x) π and p−(x) = − arccos(x) π 1 − for x ∈ [−1, 1] (rather than x ∈ [0, 1]). Here we present the lower convex envelope of each of p+(x) and p−(x). Lemma 7. Let α = min−1<x<1 1 − arccos(x) π x+1 2 ((cid:39) 0.8785672) and β = arg min −1<x<1 1 − arccos(x) π x+1 2 ((cid:39) 0.6891577). The lower convex envelope of p+(x) is given by p+(x) = (cid:18) x + 1 (cid:19) α 1 − 2 arccos(x) π 14 (−1 ≤ x ≤ β), (β < x ≤ 1), and the lower convex envelope of p−(x) is given by (cid:18) − 1 − (cid:19) (cid:18) x + 1 π arccos(x) (α − 1) − α 2 (cid:19) (−1 ≤ x ≤ −β), (−β < x ≤ 1). p−(x) = The following lemma lower bounds the expected modularity value of the output of Algorithm 2. Lemma 8. Let Cout be the output of Algorithm 2. It holds that E[Q(Cout)] ≥ p+(2z ∗ + − 1) + p−(−1 − 2z ∗ −). Proof. Recall that Cout(i) for each i ∈ V denotes the (unique) cluster in Cout that includes the vertex i. Note here that δ(Cout(i),Cout(j)) for each (i, j) ∈ P is a random variable, which takes 1 with probability p+(x∗ ij). The expectation E[Q(Cout)] is lower bounded as follows: ij) and 0 with probability 1 − p+(x∗ (cid:18) (cid:19) E[Q(Cout)] = E Aij − didj 2m δ(Cout(i),Cout(j))  didjδ(Cout(i),Cout(j))  (cid:88) ∗ ij) ∗ ij) (i,j)∈P (i,j)∈P 2m 2m (cid:88) (cid:88)  1  1 (cid:88) (cid:88) (cid:18) Aij (cid:88)  (cid:88) (i,j)∈P (i,j)∈P 2m 1 2m 1 2m (i,j)∈P = ≥ = = E Aijδ(Cout(i),Cout(j)) − Aijp+(x ∗ ij) + 1 4m2 Aijp+(x ∗ ij) + (cid:19) (cid:18) Aij (cid:19) p+(x ∗ ij) + 1 4m2 (cid:88)  + p− (i,j)∈P 1 4m2 (i,j)∈P (i,j)∈P (cid:88) (cid:88) (cid:18) didj  (cid:88) 4m2 (i,j)∈P didjp−(x didjp−(x (cid:19) (cid:18) didj p−(x ∗ ij) (cid:19) (i,j)∈P 4m2  ∗ ij x ∗ ij x ≥ p+ = p+(2z 2m (i,j)∈P ∗ + − 1) + p−(−1 − 2z ∗ −), where the last inequality follows from Jensen’s inequality. The following lemma provides an additive approximation error of Algorithm 2 by evaluating the above lower bound on E[Q(Cout)] using the value of OPTcut. Lemma 9. It holds that E[Q(Cout)] ≥ OPTcut − Proof. Since −1 ≤ z∗− ≤ −1/2 by Lemma 6, we have 0 ≤ −1 − 2z∗− ≤ 1 and hence ∗ −. = (α − 1) + αz ∗ −) = (α − 1) − α p−(−1 − 2z 2 (cid:19) (cid:19) . α − 1 2 ∗ + − 1) − ∗ + − p+(2z z (cid:18) (cid:18) (−1 − 2z∗−) + 1 15 Thus, recalling z∗ + + z∗− ≥ OPTcut, we obtain p+(2z ∗ + − 1) + p−(−1 − 2z ∗ ∗ −) ≥ (OPTcut − z + − z ∗ = (OPTcut − z + − z ∗ = OPTcut − z + + p+(2z ∗ ≥ OPTcut − z + + p+(2z ∗ = OPTcut − z + + p+(2z ∗ −) + p+(2z ∗ −) + p+(2z ∗ ∗ + − 1) + p−(−1 − 2z −) ∗ ∗ − + − 1) + (α − 1) + αz ∗ ∗ − + − 1) + (α − 1) + (α − 1)z ∗ + − 1) + (α − 1) + (α − 1)(−1/2) ∗ + − 1) + (α − 1)/2. Combining this with Lemma 8, we have E[Q(Cout)] ≥ p+(2z ∗ + − 1) + p−(−1 − 2z ∗ −) ≥ OPTcut − ∗ + − p+(2z z ∗ + − 1) − α − 1 2 (cid:18) (cid:19) , as desired. For simplicity, we define the function g(x) = x − p+(2x − 1) − α − 1 2 for x ∈ [1/2, 1]. Then, the inequality of the above lemma can be rewritten as E[Q(Cout)] ≥ OPTcut − g(z ∗ +). The following lemma analyzes the worst-case performance of Algorithm 2; thus, it provides the (cid:17) π2−4 π (cid:16)√ π α 2 − additive approximation error of Algorithm 2. Lemma 10. It holds that Proof. If 1/2 ≤ x ≤ (β + 1)/2 ((cid:39) 0.844579), then 0 ≤ 2x − 1 ≤ β holds, and hence max 1/2≤x≤1 g(x) = g(x) = x − α arccos + 2π √π2 − 4 (cid:18) (2x − 1) + 1 (cid:19) ((cid:39) 0.165973). (cid:18) (cid:19) 1 2 (α − 1) 2 − = (1 − α) x + . Otherwise (i.e., (β + 1)/2 < x ≤ 1), it holds that β < 2x − 1 ≤ 1, and thus 2 (cid:18) g(x) = x − 1 − arccos(2x − 1) π (α − 1) . 2 Summarizing the above, we have (cid:19) (cid:18) (1 − α) (cid:18) x − 1 2 x + arccos(2x − 1) π 1 − (cid:19) (α − 1) 2 − g(x) = (cid:19) , (cid:19) β + 1 2 < x ≤ 1 ((cid:39) 0.844579) . − (cid:19) (cid:18) 1 (cid:18) β + 1 2 ≤ x ≤ 2 (cid:16)√ (cid:17) π2−4 π of z∗ Figure 3 plots the above additive approximation error of Algorithm 2 with respect to the value +. By simple calculation, we have which is attained at x = 1 g(x) = √π2 − 4 2π + arccos π α 2 , − max 1/2≤x≤1 √ 2 + π2−4 2π ((cid:39) 0.885589). 16 Figure 3: An illustration of the additive approximation error of Algorithm 2 with respect to the value of z∗ +. Specifically, the function g(x) = x − p+(2x − 1) − (α − 1)/2 for x ∈ [1/2, 1] is plotted. The maximum value of g(x) is attained at x = 1 √ 2 + π2−4 2π ((cid:39) 0.885589). Finally, we present a lower bound on E[Q(Cout)] with respect to the value of OPTcut (rather +). Specifically, we have the following theorem. than z∗ Theorem 2. It holds that In particular, if OPTcut ≥ √ π2−4 2π E[Q(Cout)] > OPTcut − 0.16598. ((cid:39) 0.385589) holds, then E[Q(Cout)] ≥ OPTcut − g(OPTcut + 1/2). Proof. From Lemmas 9 and 10, it follows immediately that E[Q(Cout)] > OPTcut − 0.16598. (cid:104) 1 √ (cid:105) π2−4 2π holds. Clearly, . Therefore, we have Here we prove the remaining part of the theorem. Assume that OPTcut ≥ , 1 the function g(x) is monotonically decreasing over the interval √ 2 + π2−4 2π E[Q(Cout)] ≥ OPTcut − g(z ∗ +) ≥ OPTcut − g(OPTcut + 1/2), where the second inequality follows from z∗ + ≥ OPTcut + 1/2. Figure 4 depicts the above lower bound on E[Q(Cout)]. As can be seen, if OPTcut is close to 1/2, then Algorithm 2 obtains a nearly-optimal solution. 5 Related Problems In this section, we demonstrate that our additive approximation algorithm for the modularity maximization problem can be extended to some related problems. 17 0.50.60.70.80.9100.10.20.3←0.1659730.844579↓0.885589↓z∗+Additiveapproximationerror Figure 4: An illustration of the lower bound on the expected modularity value of the output of Algorithm 2. written as Modularity maximization on edge-weighted graphs. First, we consider community de- tection in edge-weighted graphs. Let G = (V, E, w) be a weighted undirected graph consisting of and W =(cid:80){i,j}∈E wij. The weighted modularity, which was introduced by Newman [27], can be n = V vertices, m = E edges, and weight function w : E → R>0. For simplicity, let wij = w(i, j) where si represents the weighted degree of i ∈ V (i.e., si = (cid:80){i,j}∈E wij). We consider the weighted modularity maximization problem: given a weighted undirected graph G = (V, E, w), we are asked to find a partition C of V that maximizes the weighted modularity. Since this problem is a generalization of the modularity maximization problem, it is also NP-hard. Our additive approximation algorithm for the modularity maximization problem can be gen- δ(C(i),C(j)), Qw(C) = (cid:88) (cid:88) wij − i∈V j∈V sisj 2W 1 2W (cid:16) (cid:17) eralized to the weighted modularity maximization problem. In fact, it suffices to set The analysis of the additive approximation error is similar; thus we have the following corollary. Corollary 1. There exists a polynomial-time 4 π gorithm for the weighted modularity maximization problem. cos -additive approximation al- qij = wij 2W − sisj 4W 2 (cid:16) for each i, j ∈ V. (cid:16) 3−√ 5 (cid:17) √ − 1+ 8 5 (cid:17) Modularity maximization on directed graphs. Next we consider community detection in directed graphs. Let G = (V, A) be a directed graph consisting of n = V vertices and m = A edges. The directed modularity, which was introduced by Leicht and Newman [23], can be written as Qd(C) = 1 m i din dout j m δ(C(i),C(j)), (cid:33) (cid:32) (cid:88) (cid:88) i∈V j∈V Aij − 18 00.10.20.30.40.500.10.20.30.40.50.165973↓0.385589↓OPTcutLowerboundonE[Q(Cout)]OPTcuttrivialLB where Aij is the (i, j) component of the (directed) adjacency matrix A of G, and din i and dout , respectively, represent the in- and out-degree of i ∈ V . Note that there is no factor of 2 in the denominators, unlike the (undirected) modularity. This is due to the directed counterpart of the null model used in the definition [23]. We consider the directed modularity maximization problem: given a directed graph G = (V, A), we are asked to find a partition C of V that maximizes the di- rected modularity. As mentioned in DasGupta and Desai [12], this problem is also a generalization of the modularity maximization problem, and thus NP-hard. i Our additive approximation algorithm for the modularity maximization problem can also be generalized to the directed modularity maximization problem. In fact, it suffices to set The analysis of the additive approximation error is also similar; thus we have the following corollary. Corollary 2. There exists a polynomial-time 4 π gorithm for the directed modularity maximization problem. cos -additive approximation al- qij = Aij m − dout i din j m2 for each i, j ∈ V. (cid:16) (cid:16) 3−√ 5 (cid:17) (cid:17) √ − 1+ 8 5 Barber’s bipartite modularity maximization. Finally, we consider community detection in bipartite graphs. Let G = (V, E) be an undirected bipartite graph consisting of n = V vertices and m = E edges, where V can be divided into V1 and V2 so that every edge in E has one endpoint in V1 and the other in V2. Although the modularity is applicable to community detection in bipartite graphs, the null model used in the definition does not reflect the structural property of bipartite graphs. Thus, if we know that the input graphs are bipartite, the modularity is not an appropriate quality function. To overcome this concern, Barber [4] introduced a variant of the modularity, which is called the bipartite modularity, for community detection in bipartite graphs. The bipartite modularity can be written as (cid:18) (cid:88) (cid:88) i∈V1 j∈V2 (cid:19) Qb(C) = 1 m Aij − didj m δ(C(i),C(j)). Note again that there is no factor of 2 in the denominators. This is due to the bipartite counterpart of the null model used in the definition [4]. We consider Barber’s bipartite modularity maximization problem: given an undirected bipartite graph G = (V, E), we are asked to find a partition C of V that maximizes the bipartite modularity. This problem is known to be NP-hard [26]. Our additive approximation algorithm for the modularity maximization problem is applicable to Barber’s bipartite modularity maximization problem. For each i, j ∈ V , we set  Aij m − 0 qij = didj m2 if i ∈ V1 and j ∈ V2, otherwise. (cid:16) (cid:16) 3−√ (cid:17) (cid:17) The analysis of the additive approximation error is again similar; thus we have the following corollary. √ − 1+ Corollary 3. There exists a polynomial-time gorithm for Barber’s bipartite modularity maximization problem. 4 π cos 5 8 5 -additive approximation al- 19 (cid:16) (cid:16) 3−√ (cid:17) (cid:17) (cid:16) 3−√ 5 6 Conclusions (cid:17) 8 5 5 cos 4 π In this study, we have investigated the approximability of modularity maximization. Specifically, we have proposed a polynomial-time -additive approximation algorithm for √ − 1+ √ − 1+ the modularity maximization problem. Note here that cos 8 < 0.42084 holds; thus, this improves the current best additive approximation error of 0.4672, which was recently provided by Dinh, Li, and Thai [13]. Interestingly, our analysis has also demonstrated that the proposed algorithm obtains a nearly-optimal solution for any instance with a very high modularity value. Moreover, we have proposed a polynomial-time 0.16598-additive approximation algorithm for the maximum modularity cut problem. It should be noted that this is the first non-trivial approx- imability result for the problem. Finally, we have demonstrated that our additive approximation algorithm for the modularity maximization problem can be extended to some related problems. 4 π 5 There are several directions for future research. It is quite interesting to investigate additive approximation algorithms for the modularity maximization problem more deeply. For example, it is challenging to design an algorithm that has a better additive approximation error than that of Hyperplane(k∗). As another approach, is it possible to improve the additive approximation error of Hyperplane(k∗) by completely different analysis? Our analysis implies that if we lower bound the expectation E[Q(Ck)] by the form in Lemma 3, our additive approximation error of cos is the best possible. As another future direction, the inapproximability of the modularity maximization problem in terms of additive approximation should be investigated, as mentioned in Dinh, Li, and Thai [13]. Does there exist some constant  > 0 such that computing an -additive approximate solution for the modularity maximization problem is NP-hard? (cid:16) 3−√ √ − 1+ 4 π (cid:17) 5 8 5 Acknowledgments YK is supported by a Grant-in-Aid for Research Activity Start-up (No. 26887014). AM is sup- ported by a Grant-in-Aid for JSPS Fellows (No. 26-11908). References [1] G. Agarwal and D. Kempe. Modularity-maximizing graph communities via mathematical programming. Eur. Phys. J. B, 66(3):409–418, 2008. [2] N. Alon, K. Makarychev, Y. Makarychev, and A. Naor. Quadratic forms on graphs. In STOC ’05: Proceedings of the 37th Annual ACM Symposium on Theory of Computing, pages 486–493, 2005. [3] N. Bansal, A. Blum, and S. Chawla. Correlation clustering. Machine Learning, 56(1-3):89–113, 2004. [4] M. J. Barber. Modularity and community detection in bipartite networks. Phys. Rev. E, 76:066102, 2007. [5] V. D. Blondel, J.-L. Guillaume, R. Lambiotte, and E. Lefebvre. Fast unfolding of communities in large networks. J. Stat. Mech.: Theory Exp. (2008) P10008. [6] U. Brandes, D. Delling, M. Gaertler, R. Gorke, M. Hoefer, Z. Nikoloski, and D. Wagner. On modularity clustering. IEEE Trans. Knowl. Data Eng., 20(2):172–188, 2008. 20 [7] S. Cafieri, A. Costa, and P. Hansen. Reformulation of a model for hierarchical divisive graph modularity maximization. Ann. Oper. Res., 222(1):213–226, 2014. [8] S. Cafieri, P. Hansen, and L. Liberti. Locally optimal heuristic for modularity maximization of networks. Phys. Rev. E, 83:056105, 2011. [9] M. Charikar, V. Guruswami, and A. Wirth. Clustering with qualitative information. J. Comput. Syst. Sci., 71(3):360–383, 2005. [10] M. Charikar and A. Wirth. Maximizing quadratic programs: Extending Grothendieck’s in- equality. In FOCS ’04: Proceedings of the 45th Annual IEEE Symposium on Foundations of Computer Science, pages 54–60, 2004. [11] A. Clauset, M. E. J. Newman, and C. Moore. Finding community structure in very large networks. Phys. Rev. E, 70:066111, 2004. [12] B. DasGupta and D. Desai. On the complexity of Newman’s community finding approach for biological and social networks. J. Comput. Syst. Sci., 79(1):50–67, 2013. [13] T. N. Dinh, X. Li, and M. T. Thai. Network clustering via maximizing modularity: Ap- proximation algorithms and theoretical limits. In ICDM ’15: Proceedings of the 2015 IEEE International Conference on Data Mining, pages 101–110, 2015. [14] T. N. Dinh and M. T. Thai. Community detection in scale-free networks: Approximation algorithms for maximizing modularity. IEEE J. Sel. Areas Commun., 31(6):997–1006, 2013. [15] J. Duch and A. Arenas. Community detection in complex networks using extremal optimiza- tion. Phys. Rev. E, 72:027104, 2005. [16] S. Fortunato. Community detection in graphs. Phys. Rep., 486(3):75–174, 2010. [17] S. Fortunato and M. Barth´elemy. Resolution limit in community detection. Proc. Natl. Acad. Sci. U.S.A., 104(1):36–41, 2007. [18] A. Frieze and R. Kannan. The regularity lemma and approximation schemes for dense prob- In FOCS ’96: Proceedings of the 37th Annual IEEE Symposium on Foundations of lems. Computer Science, pages 12–20, 1996. [19] D. Gibson, R. Kumar, and A. Tomkins. Discovering large dense subgraphs in massive graphs. In VLDB ’05: Proceedings of the 31st International Conference on Very Large Data Bases, pages 721–732, 2005. [20] M. X. Goemans and D. P. Williamson. Improved approximation algorithms for maximum cut and satisfiability problems using semidefinite programming. J. ACM, 42(6):1115–1145, 1995. [21] B. H. Good, Y.-A. de Montjoye, and A. Clauset. Performance of modularity maximization in practical contexts. Phys. Rev. E, 81:046106, 2010. [22] R. Guimer`a and L. A. N. Amaral. Functional cartography of complex metabolic networks. Nature, 433(7028):895–900, 2005. [23] E. A. Leicht and M. E. J. Newman. Community structure in directed networks. Phys. Rev. Lett., 100:118703, 2008. 21 [24] C. P. Massen and J. P. K. Doye. Identifying communities within energy landscapes. Phys. Rev. E, 71:046101, 2005. [25] A. Miyauchi and Y. Miyamoto. Computing an upper bound of modularity. Eur. Phys. J. B, 86:302, 2013. [26] A. Miyauchi and N. Sukegawa. Maximizing Barber’s bipartite modularity is also hard. Opti- mization Letters, 9(5):897–913, 2015. [27] M. E. J. Newman. Analysis of weighted networks. Phys. Rev. E, 70:056131, 2004. [28] M. E. J. Newman. Modularity and community structure in networks. Proc. Natl. Acad. Sci. U.S.A., 103(23):8577–8582, 2006. [29] M. E. J. Newman and M. Girvan. Finding and evaluating community structure in networks. Phys. Rev. E, 69:026113, 2004. [30] T. Richardson, P. J. Mucha, and M. A. Porter. Spectral tripartitioning of networks. Phys. Rev. E, 80:036111, 2009. [31] V. Spirin and L. A. Mirny. Protein complexes and functional modules in molecular networks. Proc. Natl. Acad. Sci. U.S.A., 100(21):12123–12128, 2003. [32] D. P. Williamson and D. B. Shmoys. The Design of Approximation Algorithms. Cambridge University Press, 2011. A Proof of Lemma 5 (cid:16) 3−√ 5 (cid:17) We start with the following fact. Fact 1. If OPT < cos 4 π √ holds, then f1(OPT) ≥ 1+ . Proof. Assume that OPT < cos 4 5 (cid:16) 3−√ (cid:17) holds, then f1(OPT) < 1+ 4 5 4 π holds. Then, we have f1(OPT) = 1 − arccos(OPT) π < 1 − arccos cos The proof of the second statement is similar. 5 . Conversely, if OPT ≥ cos (cid:16) 3−√ 5 4 π (cid:17) √ (cid:16) (cid:17) (cid:16) 3−√ 5 4 π (cid:17)(cid:17) 1 + √5 . = 5 4 π 4 π (cid:16) 3−√ (cid:80)k−1 (cid:17)k (cid:16) 1+ i=0 (2x)i for x ∈ [0, 1]. Then, we have − 1 (cid:104) 2 − 1 ≤ (cid:16) 1+ 1 23−1 (cid:17)3 √ √ 1+ 2 5 = First, we consider the case where OPT < cos holds. Let us fix an arbitrary integer (cid:33) k ≥ 3. We define the function lk(x) = 1 2k−1 (cid:32) 1 + √5 1 2 and lk lk(0) = 0 < 0 + 5 − 1 √ 2 − 1 Moreover, the function lk(x) is convex. Thus, we have lk(x) < x + 1/2 for any x ∈ we evaluate the value of 1 2k−1 5 √ = 1+ 4 5 2 1 + √5 (cid:17) 4 √ + 1 2 . 0, 1+ 4 5 . Here gk(OPT) − g2(OPT) = (OPT − fk(OPT) + 1/2k) − (OPT − f2(OPT) + 1/4) = (f2(OPT) − 1/4) − (fk(OPT) − 1/2k) = (f1(OPT) − 1/2) (f1(OPT) + 1/2) − (f1(OPT) − 1/2) · lk(f1(OPT)) = (f1(OPT) − 1/2) ((f1(OPT) + 1/2) − lk(f1(OPT))) . 22 From the definition, f1(OPT) ≥ 1/2 holds. By Fact 1, we get f1(OPT) + 1/2 > lk(f1(OPT)). Therefore, we have gk(OPT) ≥ g2(OPT), which means that arg mink∈Z>0 gk(OPT) contains 1 or 2. holds. It suffices to show that for any Next, we consider the case where OPT ≥ cos 4 π 5 (cid:16) 3−√ (cid:17) integer k ≥ log2 n, gk+1(OPT) > gk(OPT). In addition to Fact 1, we have the following two facts. Fact 2 (see Lemma 2.1 in [12]). It holds that OPT ≤ 1 − 1/n. Fact 3. For any x ∈ [0, 1], it holds that √2x ≤ arccos (1 − x). Proof. By Jordan’s inequality (i.e., sin t ≤ t for any t ∈ [0, π/2]), we have (cid:90) y (cid:90) y 0 t dt 0 sin t dt ≤ y2 2 y2 2 ≤ cos y arccos(z)2 ⇔ 1 − cos y ≤ ⇔ 1 − ≤ z ⇔ 1 − ⇔ 2(1 − z) ≤ arccos(z)2 √2x ≤ arccos(1 − x) ⇔ 2 (∀y ∈ [0, π/2]) (∀y ∈ [0, π/2]) (∀y ∈ [0, π/2]) (∀z ∈ [0, 1]) (∀z ∈ [0, 1]) (∀x ∈ [0, 1]). Using the above facts, we prove the inequality. For any integer k ≥ log2 n, we have gk+1(OPT) − gk(OPT) = (OPT − fk+1(OPT) + 1/2k+1) − (OPT − fk(OPT)+1/2k) = (1 − f1(OPT))fk(OPT) − 1/2k+1 fk(OPT) − 1/2k+1 = arccos(OPT) π ≥ ≥ = ≥ > arccos(1 − 1/n) √2 π√n 1 2√2 π√n fk(OPT) − 1/2k+1 (cid:33)  π (cid:32) fk(OPT) − 1/2k+1  2√2 (cid:33)k (cid:32) (cid:33) (cid:32) (cid:32) (2 · f1(OPT))k − 1 (cid:16) 22/3(cid:17)k (cid:33) n1/6 − 1 π√n 2√2 π√n 2√2 π 1 + √5 − 1 − 1 2 2k+1 1 2k+1 1 2k+1 1 2k+1 ≥ > 0, where the last inequality follows from n ≥ 2 by the assumption that OPT ≥ cos 23 (By Fact 2) (By Fact 3) (By Fact 1) (cid:16) 3−√ 5 4 π (cid:17) holds.
1707.01149
1
1707
2017-07-04T20:50:42
Analyzing the Spread of Chagas Disease with Mobile Phone Data
[ "cs.SI", "cs.CY", "physics.soc-ph" ]
We use mobile phone records for the analysis of mobility patterns and the detection of possible risk zones of Chagas disease in two Latin American countries. We show that geolocalized call records are rich in social and individual information, which can be used to infer whether an individual has lived in an endemic area. We present two case studies, in Argentina and in Mexico, using data provided by mobile phone companies from each country. The risk maps that we generate can be used by health campaign managers to target specific areas and allocate resources more effectively.
cs.SI
cs
2016 IEEE/ACM International Conference on Advances in Social Networks Analysis and Mining (ASONAM) Analyzing the Spread of Chagas Disease with Mobile Phone Data Juan de Monasterio∗, Alejo Salles∗†, Carolina Lang∗, Diego Weinberg‡, Martin Minnoni§, Matias Travizano§, Carlos Sarraute§ ∗FCEyN, Universidad de Buenos Aires, Argentina †Instituto de C´alculo and CONICET, Argentina ‡Fundaci´on Mundo Sano, Paraguay 1535, Buenos Aires, Argentina §Grandata Labs, Bartolome Cruz 1818, Vicente Lopez, Argentina 7 1 0 2 l u J 4 ] I S . s c [ 1 v 9 4 1 1 0 . 7 0 7 1 : v i X r a Abstract-We use mobile phone records for the analysis of mobility patterns and the detection of possible risk zones of Chagas disease in two Latin American countries. We show that geolocalized call records are rich in social and individual information, which can be used to infer whether an individual has lived in an endemic area. We present two case studies, in Argentina and in Mexico, using data provided by mobile phone companies from each country. The risk maps that we generate can be used by health campaign managers to target specific areas and allocate resources more effectively. I. INTRODUCTION Chagas disease is a tropical parasitic epidemic of global reach, spread mostly across 21 Latin American countries. The World Health Organization (WHO) estimates more than six million infected people worldwide [1]. Caused by the Trypanosoma cruzi parasite, its transmission occurs mostly in the American endemic regions via the Triatoma infestans insect family (also called "kissing bug", and known by many local names such as "vinchuca" in Argentina, Bolivia, Chile and Paraguay, and "chinche" in Central America). In recent years and due to globalization and migrations, the disease has become a health issue in other continents [2], particularly in countries who receive Latin American immigrants such as Spain [3] and the United States [4], making it a global health problem. A crucial characteristic of the infection is that it may last 10 to 30 years in an individual without being detected [5], which greatly complicates effective detection and treatment. About 30% of individuals with chronic Chagas disease will develop life-threatening cardiomyopathies or gastrointestinal disorders, whereas the remaining individuals will never develop symp- toms. Long-term human mobility (particularly seasonal and permanent rural-urban migration) thus plays a key role in the spread of the epidemic [6]. Relevant routes of transmis- sion also include blood transfusion, congenital contagion – with an estimated 14,000 newborns infected each year in the Americas [7]–, organ transplants, accidental ingestion of food contaminated by Trypanosoma cruzi, and even, in a minor scale, by laboratory accidents. The spatial dissemination of a congenitally transmitted disease sidesteps the available measures to control risk groups, and shows that individuals who have not been exposed to the disease vector should also be included in detection campaigns. Mobile phone records contain information about the move- ments of large subsets of the population of a country, and make them very useful to understand the spreading dynamics of infectious diseases. They have been used to understand the diffusion of malaria in Kenya [8] and in Ivory Coast [9], including the refining of infection models [10]. The cited works on Ivory Coast were performed using the D4D (Data for Development) challenge datasets released in 2013. Tizzoni et al. [11] compare different mobility models using theoretical approaches, available census data and models based on CDRs interactions to infer movements. They found that the models based on CDRs and mobility census data are highly correlated, illustrating their use as mobility proxies. Mobile phone data has also been used to predict the geographic spread and timing of Dengue epidemics [12]. This analysis was performed for the country of Pakistan, which is representative of many countries on the verge of countrywide endemic dengue transmission. Other works di- rectly study CDRs to characterize human mobility and other sociodemographic information. A complete survey of mobile traffic analysis articles may be found in [13], which also reviews additional studies based on the Ivory Coast dataset mentioned above. In this work, we discuss the use of mobile phone records –also known as Call Detail Records (CDRs)– for the analysis of mobility patterns and the detection of possible risk zones of Chagas disease in two Latin American countries. Key health expertise on the subject was provided by the Mundo Sano Foundation. We generate predictions of population movements between different regions, providing a proxy for the epidemic spread. Our objective is to show that geolocalized call records are rich in social and individual information, which can be used to determine whether an individual has lived in an epidemic area. We present two case studies, in Argentina and in Mexico, using data provided by mobile phone companies from each country. This is the first work that leverages mobile phone data to better understand the diffusion of the Chagas disease. 1 2016 IEEE/ACM International Conference on Advances in Social Networks Analysis and Mining (ASONAM) II. CHAGAS DISEASE IN ARGENTINA AND MEXICO A. Key Facts and Endemic Zone in Argentina For more than 50 years, vector control campaigns have been underway in Argentina as the main epidemic counter- measure. The Gran Chaco, situated in the northern part of the country, is hyperendemic for the disease [14]. A map of this ecoregion is shown in Figure 1. The ecoregion's low socio- demographic conditions further support the parasite's lifecycle, where domestic interactions between humans, triatomines and animals foster the appearance of new infection cases, particu- larly among rural and poor areas. This region is considered as the endemic zone EZ in the analysis described in Section IV and Section V. Figure 1. The Gran Chaco ecoregion in South America. The dynamic interaction of the triatomine infested areas and the human mobility patterns create a difficult scenario to track down individuals or spots with high prevalence of infected people or transmission risk. Available methods of surveying the state of the Chagas disease in Argentina nowadays are limited to individual screenings of individuals. Recent national estimates indicate that there exist between 1.5 and 2 million individuals carrying the parasite, with more than seven million exposed. National health systems face many difficulties to effectively treat the disease. In Argentina, less than 1% of infected people are diagnosed and treated (the same statistic holds at the world level). Even though governmental programs have been ongoing for years now [15], data on the issue is scarce or hardly accessible. This presents a real obstacle to ongoing research and coordination efforts to tackle the disease in the region. B. Key Facts and Endemic Zone in Mexico In 2004, the joint work of Instituto Nacional de Cardiolog´ıa "Ignacio Ch´avez" and Instituto de Biolog´ıa de la UNAM resulted in a Chagas disease database for Mexico [16]. Re- viewing positive serology in blood banks and human reported cases per state, an epidemic risk map description was produced 2 Figure 2. Endemic region EZ for Mexico. to geographically situate the disease. Based on this data, we defined the Mexican epidemic area, selecting the states having the top 25% prevalence rates nationwide. The resulting risk region is shown in Figure 2. It covers most of the South region of the country and includes the states of Jalisco, Oaxaca, Veracruz, Guerrero, Morelos, Puebla, Hidalgo and Tabasco. This region is considered as the endemic zone EZ for the Mexican case in the analysis described in Sections IV and V. The authors of [17] provide an extensive review of the research reports on Chagas disease in Mexico. The review is very critical, stating that there are no effective vector control programs in Mexico; and that the actual prevalence of the disease can only be estimated because no official reporting of cases is performed. According to [18], there are a total of 18 endemic areas in Mexico, located in the southeast, and these areas include the states of Oaxaca, Jalisco, Yucat´an, Chiapas, Veracruz, Puebla, Guerrero, Hidalgo, and Morelos, all of them with rural areas. Chiapas, Oaxaca, Puebla, Veracruz and Yucat´an are among the most affected states (where the prevalence may exceed 10%), although cases have been reported in most areas of the country [16], [18]. Despite the lack of official reports, an estimate of the number of Trypanosoma cruzi infections by state in the country indicates that the number of potentially affected people in Mexico is about 5.5 million [17]. Mexico, together with Bolivia, Colombia, and Central America, are among the countries most affected by this neglected tropical disease (NTD) [19]. The disease doesn't know about borders: Chagas and other neglected tropical diseases present in the north of Mexico remain highly endemic in the south of Texas as well [20]. In recent years there has been a focus on treating the disease with two available medications, benznidazole or nifurtimox. A study that explores the access to these two drugs in Mexico shows that less than 0.5% of those who are infected with the disease received treatment in Mexico in years [21]. People from endemic areas of Chagas disease tend to migrate to industrialized cities of the country, mainly Mexico City, in search of jobs. In accordance with this movement, a report showed that infected children under 5 year of age are frequently distributed in urban rather than in rural areas, indi- cating that the disease is becoming urbanized in Mexico [22]. Therefore, as in the Argentinian case, the study of long-term 2016 IEEE/ACM International Conference on Advances in Social Networks Analysis and Mining (ASONAM) mobility is crucial to understand the spread of the Chagas disease in Mexico. III. MOBILE PHONE DATA SOURCES Our data source is anonymized traffic information from two mobile operators, in Argentina and in Mexico. For our purposes, each record is represented as a tuple (cid:104)i, j, t, d, l(cid:105), where user i is the caller, user j is the callee, t is the date and time of the call, d is the direction of the call (incoming or outgoing, with respect to the mobile operator client), and l is the location of the tower that routed the communication. The dataset does not include personal information from the users, such as name or phone number. The users privacy is assured by differentiating users by their hashed ID, with encryption keys managed exclusively by the telephone company. Data was preprocessed excluding users whose monthly cellphone use either did not surpass a minimal number of calls µ or exceeded a maximal number M. This ensures we leave out outlying users such as call-centers or dead phones. In both datasets, we used µ = 5 and M = 400. We then aggregate the call records for a five month period into an edge list (ni, nj, wi,j) where nodes ni and nj represent users i and j respectively and wi,j is a boolean value indicating whether these two users have communicated at least once within the five month period. This edge list will represent our mobile graph G = (cid:104)N ,E(cid:105) where N denotes the set of nodes (users) and E the set of communication links. We note that only a subset NC nodes in N are clients of the the remaining nodes N \ NC are users mobile operator, that communicated with users in NC but themselves are not clients of the mobile operator. Since geolocation information is available only for users in NC, in the analysis we considered the graph GC = (cid:104)NC,EC(cid:105) of communications between clients of the operator. a) Datasets Information: The Argentinian dataset con- tains CDRs collected over a period of 5 months, from Novem- ber 2011 to March 2012. The raw data logs contain around 50 million calls per day. The Mexican data source is an anonymized dataset from a national mobile phone operator. Data is available for every call made within a period of 19 months from January 2014 to December 2015. The raw logs contain about 12 million calls per day for more than 8 million users that accessed the telecommunication company's (telco) network to place the call. This means that users from other companies are logged, as long as one of the users registering the call is a client of the operator. In practice, we only considered CDRs between users in NC since geolocalization was only possible for this group. b) Data Limitations: Although a lot of information is available in the CDR datasets, there may be limitations in their representativeness of the whole population. In each case, data is sourced from a single mobile phone operator, and no information is given on the distribution of its users, thus calls might in principle not represent correctly social interactions and movements between two given jurisdictions. Also, not all user movements will be captured by the log records. However, these limitations are offset by the huge datasets' sizes, from which we can safely assume that the amount of users observed in each set is sufficient to correlate real mobility or social links between different areas. IV. METHODOLOGY In this section we describe the methodology used to generate risk maps for the Chagas disease in Argentina and in Mexico. A. Home Detection The first step of the process involves determining the area in which each user lives. Having the granularity of the geolocated data at the antenna level, we can match each user u ∈ NC with its home antenna Hu. To do so, we assume Hu as the antenna in which user u spends most of the time during weekday nights. This, according to our categorization of types of days of the week, corresponds to Monday to Thursday nights, from 8pm to 6am of the following day. This was based on the assumption that on any given day, users will be located at home during night time [23], [24]. Note that users for which the inferred home antenna is located in the endemic zone EZ will be considered the set of residents of EZ. In the case of Argentina, the risk area is the Gran Chaco ecoregion, as described in Section II-A; whereas in the case of Mexico, we used the region described in Section II-B. B. Detection of Vulnerable Users Given the set of inhabitants of the risk area, we want to find those with a high communication with residents of the endemic zone EZ. To do this, we get the list of calls for each user and then determine the set of neighbors in the social graph GC. For each resident of the endemic zone, we tag all his neighbors as potentially vulnerable. We also tag the calls to (from) a certain antenna from (to) residents of the endemic area EZ as vulnerable calls. The next step is to aggregate this data for every antenna. Given an antenna a, we will have: • The total number of residents Na (this is, the number of people for which that is their home antenna). • The total number of residents which are vulnerable Va. • The total volume of outgoing calls Ca from every an- tenna. • From the outgoing calls, we extracted every call that had a user whose home is in the endemic area EZ as a receiver V Ca (vulnerable calls). These four numbers (cid:104)Na, Va, Ca, V Ca(cid:105) are the indicators for each antenna in the studied country. C. Heatmap Generation With the collected data, we generated heatmaps to visualize the mentioned antenna indicators, overlapping these heatmaps with political maps of the region taken for study. A circle is generated for each antenna, where the area depends on the population living in the antenna Na; and the color is related to the fraction Va/Na of vulnerable users living there. 3 2016 IEEE/ACM International Conference on Advances in Social Networks Analysis and Mining (ASONAM) We used two filtering parameters to control which antennas are plotted. • β: The antenna is plotted if its fraction of vulnerable users • mv: The antenna is plotted if its population is bigger than is higher than β. mv. These parameters were tuned differently for different re- gions. For example: an antenna whose vulnerable percentage would be considered low at the national level can be locally high when zooming in at a more regional level. V. RESULTS AND OBSERVATIONS A. Risk Maps for Argentina Figure 4. Risk map for Cordoba and Santa Fe provinces, filtered according to β = 0.15. Aires, with special focus on the metropolitan area of Greater Buenos Aires whose heatmap is shown in Figure 5. In some cases, antennas stood out for having a significantly higher link to the epidemic area than their adjacent antennas. Our objective here was to enhance the visualization in areas outside of Gran Chaco looking for possible host communities of migrants from the ecoregion. High risk antennas were separately listed and manually located in political maps. This information was made available to the Mundo Sano Founda- tion collaborators who used it as an aid for their campaign planning and as education for community health workers. (a) β = 0.01 (b) β = 0.15 Figure 3. Risk map for Argentina, filtered according to β. As a first visualization, maps were drawn using a provin- cial or national scale. Advised by Mundo Sano Foundation's experts, we then focused on areas of specific epidemic interest. Figure 3 shows the risk maps for Argentina, generated with two values for the β filtering parameter, and fixing mv = 50 inhabitants per antenna. After filtering with β = 0.15, we see that large portions of the country harbor potentially vulnerable individuals. Namely, Figure 3(b) shows antennas where more that 15% of the population has social ties with the endemic region EZ. Figure 4 shows a close-up for the Cordoba and Santa Fe provinces, where we can see a gradient from the regions closer to the endemic zone EZ to the ones further away. Figure 5. Risk map for the metropolitan area of Buenos Aires, filtered with β = 0.02. B. Zooming and Detection of Vulnerable Communities As a result of inspecting the maps in Figure 3, we decided to focus visualizations in areas whose results were unexpected to the epidemiological experts. Focused areas included the provinces of Tierra del Fuego, Chubut, Santa Cruz and Buenos This analysis allowed us to specifically detect outlying communities in the focused regions. Some of these can be seen directly from the heatmap in Figure 5, where the towns of Avellaneda, San Isidro and Parque Patricios have been pinpointed. 4 2016 IEEE/ACM International Conference on Advances in Social Networks Analysis and Mining (ASONAM) C. Risk Maps for Mexico VII. FUTURE WORK With the data provided by the CDRs and the endemic region defined in Section II-B, heatmaps were generated for Mexico using the methods described in Section IV. The first generated visualizations are depicted in Figure 6, which includes a map of the country of Mexico, and a zoom-in on the South region of the country. We used mv = 80 inhabitants per antenna, and a high filtering value β = 0.50, which means that in all the antennas shown in Figure 6, more that 50% of inhabitants have a social tie with the endemic region EZ. For space reasons, we don't provide here more specific visualizations and analysis of the regions of Mexico. (a) National map (b) South region of Mexico Figure 6. Risk maps for Mexico VI. CONCLUSIONS The heatmaps shown in Section V expose a "temperature" descent from the core regions outwards. The heat is concen- trated in the ecoregion and gradually descends as we move further away. This expected behavior could be explained by the fact that calls are in general of a local nature and limited to 3 or 4 main antennas used per user. A more surprising fact is the finding of communities atyp- ical to their neighboring region. They stand out for their strong communication ties with the studied region, showing significantly higher links of vulnerable communication. The detection of these antennas through the visualizations is of great value to health campaign managers. Tools that target specific areas help to prioritize resources and calls to action more effectively. The results presented in this work show that it is possible to explore CDRs as a mean to tag human mobility. Combining social and geolocated information, the data at hand has been given a new innovative use different to the end for which the data was created (billing). Epidemic counter-measures nowadays include setting na- tional surveillance systems, vector-centered policy interven- tions and individual screenings of people. These measures require costly infrastructures to set up and be run. However, systems built on top of existing mobile networks would demand lower costs, taking advantage of the already available infrastructure. The potential value these results could add to health research is hereby exposed. Finally, the results stand as a proof of concept which can be extended to other countries or to diseases with similar characteristics. 5 The mobility and social information extracted from CDRs analysis has been shown to be of practical use for Chagas disease research. Helping to make data driven decisions which in turn is key to support epidemiological policy interventions in the region. For the purpose of continuing this line of work, the following is a list of possible extensions being considered: • Results validation. Compare against actual serology or disease prevalence surveys. Data collected from fieldwork could be fed to the algorithm in order to supervise the learning. • Differentiating rural antennas from urban ones. This is important as rural areas have conditions which are more vulnerable to the disease expansion. Trypanosoma cruzi transmission is favored by rural housing materials and domestic animals contribute to complete the parasite's lifecycle. Antennas could be automatically tagged as rural by analyzing the differences between the spatial distribution of the antennas in each area. Another goal could be to identify precarious settlements within urban areas, with the help of census data sources. • Seasonal migration analysis. Experts from the Mundo Sano Foundation underlined that many seasonal migra- tions occur in the Gran Chaco region. Workers might leave the endemic area for several months possibly intro- ducing the parasite to foreign populations. The analysis of these movements can give information on which com- munities have a high influx of people from the endemic zone. • Search for epidemiological data at a finer grain. For instance, specific historical infection cases. Splitting the endemic region according to the infection rate in different areas, or considering particular infections. ACKNOWLEDGEMENTS We thank Marcelo Paganini, Marcelo Abril and Silvia Gold from Fundaci´on Mundo Sano for their valuable input, useful discussions and support of the project. Special thanks to Adri´an Paenza who provided the original idea and motivation of the project. REFERENCES [1] WHO. Chagas disease (American trypanosomiasis). World Health Organization Fact sheets, 2016. [2] Gabriel A Schmunis and Zaida E Yadon. Chagas disease: a Latin American health problem becoming a world health problem. Acta tropica, 115(1):14–21, 2010. [3] Miriam Navarro, B´arbara Navaza, Anne Guionnet, and Rogelio L´opez- V´elez. Chagas disease in spain: need for further public health measures. PLoS Negl Trop Dis, 6(12):e1962, 2012. [4] Peter J Hotez, Eric Dumonteil, Miguel Betancourt Cravioto, Maria Elena Bottazzi, Roberto Tapia-Conyer, Sheba Meymandi, Unni Karunakara, Isabela Ribeiro, Rachel M Cohen, and Bernard Pecoul. An unfolding tragedy of chagas disease in north america. PLoS Negl Trop Dis, 7(10):e2300, 2013. [5] Anis Rassi and Joffre Marcondes de Rezende. American trypanoso- Infectious disease clinics of North America, miasis (Chagas disease). 26(2):275–291, 2012. [6] Roberto Briceno-Le´on. Chagas disease in the Americas: an ecohealth perspective. Cadernos de Sa´ude P´ublica, 25:S71–S82, 2009. 2016 IEEE/ACM International Conference on Advances in Social Networks Analysis and Mining (ASONAM) [7] OPS. Estimacion Cuantitiva de la Enfermedad del Chagas en las Americas. Organizacion Panamericana de la Salud/HDM/CD, 425- 06:1–6, 2006. [8] Amy Wesolowski, Nathan Eagle, Andrew J Tatem, David L Smith, Ab- disalan M Noor, Robert W Snow, and Caroline O Buckee. Quantifying the impact of human mobility on malaria. Science, 338(6104):267–270, 2012. [9] E Enns and J Amuasi. Human Mobility and Communication Patterns in Cote d'Ivoire: A Network Perspective for Malaria Control. NetMob D4D Challenge, pages 1–14, 2013. [10] R Chunara and EO Nsoesie. Large-scale Measurements of Network Topology and Disease Spread: A Pilot Evaluation Using Mobile Phone Data in Cote d'Ivoire. NetMob D4D Challenge, pages 1–18, 2013. [11] Michele Tizzoni, Paolo Bajardi, Adeline Decuyper, Guillaume Kon Kam King, Christian M Schneider, Vincent Blondel, Zbigniew Smoreda, Marta C Gonz´alez, and Vittoria Colizza. On the use of human mobility proxies for modeling epidemics. PLoS Comput Biol, 10(7):e1003716, 2014. [12] Amy Wesolowski, Taimur Qureshi, Maciej F Boni, Pal Roe Sundsøy, Michael A Johansson, Syed Basit Rasheed, Kenth Engø-Monsen, and Caroline O Buckee. Impact of human mobility on the emergence of dengue epidemics in Pakistan. Proceedings of the National Academy of Sciences, 112(38):11887–11892, 2015. [13] Diala Naboulsi, Marco Fiore, Stephane Ribot, and Razvan Stanica. Mobile traffic analysis: a survey. PhD thesis, Universit´e de Lyon; INRIA Grenoble-Rhone-Alpes; INSA Lyon; CNR-IEIIT, 2015. [14] OPS. Mapa de Transmisi´on vectorial del Mal de Chagas. Organizacion Panamericana de la Salud, 2014. [15] Ministerio de Salud Argentina. Plan Nacional de Chagas, 2016. [Online, accessed 9-may-2016]. [16] A Cruz-Reyes and Jos´e M Pickering-L´opez. Chagas disease in Mexico: an analysis of geographical distribution during the past 76 years-A review. Memorias do Instituto Oswaldo Cruz, 101(4):345–354, 2006. [17] Alejandro Carabarin-Lima, Mar´ıa Cristina Gonz´alez-V´azquez, Olivia Rodr´ıguez-Morales, Lidia Bayl´on-Pacheco, Jos´e Luis Rosales-Encina, Pedro Antonio Reyes-L´opez, and Minerva Arce-Fonseca. Chagas disease (american trypanosomiasis) in Mexico: an update. Acta tropica, 127(2):126–135, 2013. [18] Eric Dumonteil. Update on Chagas' disease in Mexico. Salud p´ublica de M´exico, 41(4):322–327, 1999. [19] Peter J Hotez, Eric Dumonteil, Michael J Heffernan, and Maria E Bottazzi. Innovation for the 'bottom 100 million': eliminating neglected In Hot Topics in Infection and tropical diseases in the Americas. Immunity in Children IX, pages 1–12. Springer, 2013. [20] Peter J Hotez, Maria Elena Bottazzi, Eric Dumonteil, Jesus G Valen- zuela, Shaden Kamhawi, Jaime Ortega, Samuel Ponce de Leon Rosales, Miguel Betancourt Cravioto, and Roberto Tapia-Conyer. Texas and Mexico: sharing a legacy of poverty and neglected tropical diseases. PLoS Negl Trop Dis, 6(3):e1497, 2012. [21] Jennifer M Manne, Callae S Snively, Janine M Ramsey, Marco Ocampo Salgado, Till Barnighausen, and Michael R Reich. Barriers to treatment access for Chagas disease in Mexico. PLoS Negl Trop Dis, 7(10):e2488, 2013. [22] Carmen Guzm´an-Bracho. Epidemiology of Chagas disease in Mexico: an update. TRENDS in Parasitology, 17(8):372–376, 2001. [23] Carlos Sarraute, Jorge Brea, Javier Burroni, Klaus Wehmut, Artur Ziviani, and Ignacio Alvarez-Hamelin. Social Events in a Time-Varying In Fourth International Conference on the Mobile Phone Graph. Analysis of Mobile Phone Datasets (NetMob), 2015. [24] Bal´azs Cs Cs´aji, Arnaud Browet, VA Traag, Jean-Charles Delvenne, Etienne Huens, Paul Van Dooren, Zbigniew Smoreda, and Vincent D Blondel. Exploring the mobility of mobile phone users. Physica A: Statistical Mechanics and its Applications, 2012. 6
1906.12204
1
1906
2019-06-27T10:49:34
Modularity in Multilayer Networks using Redundancy-based Resolution and Projection-based Inter-Layer Coupling
[ "cs.SI", "physics.data-an", "physics.soc-ph" ]
The generalized version of modularity for multilayer networks, a.k.a. multislice modularity, is characterized by two model parameters, namely resolution factor and inter-layer coupling factor. The former corresponds to a notion of layer-specific relevance, whereas the inter-layer coupling factor represents the strength of node connections across the network layers. Despite the potential of this approach, the setting of both parameters can be arbitrarily selected, without considering specific characteristics from the topology of the multilayer network as well as from an available community structure. Also, the multislice modularity is not designed to explicitly model order relations over the layers, which is of prior importance for dynamic networks. This paper aims to overcome the main limitations of the multislice modularity by introducing a new formulation of modularity for multilayer networks. We revise the role and semantics of both the resolution and inter-layer coupling factors based on information available from the within-layer and inter-layer structures of the multilayer communities. Also, our proposed multilayer modularity is general enough to consider orderings of network layers and their constraints on layer coupling. Experiments were carried out on synthetic and real-world multilayer networks using state-of-the-art approaches for multilayer community detection. The obtained results have shown the meaningfulness of the proposed modularity, revealing the effects of different combinations of the resolution and inter-layer coupling functions. This work also represents a starting point for the development of new optimization methods for community detection in multilayer networks.
cs.SI
cs
Modularity in Multilayer Networks using Redundancy-based Resolution and Projection-based Inter-Layer Coupling∗† Alessia Amelio1, Giuseppe Mangioni2, and Andrea Tagarelli‡1 1 Dept. of Computer Engineering, Modeling, Electronics and Systems Engineering (DIMES), University of Calabria, Rende (CS), Italy, Email: {aamelio, tagarelli}@dimes.unical.it. 2Dept. of Electrical, Electronics and Computer Engineering, University of Catania, Catania, Italy, Email: [email protected]. Abstract The generalized version of modularity for multilayer networks, a.k.a. multislice modularity, is characterized by two model parameters, namely resolution factor and inter-layer coupling factor. The former corresponds to a notion of layer-specific relevance, whereas the inter-layer coupling fac- tor represents the strength of node connections across the network layers. Despite the potential of this approach, the setting of both parameters can be arbitrarily selected, without considering specific characteristics from the topology of the multilayer network as well as from an available com- munity structure. Also, the multislice modularity is not designed to ex- plicitly model order relations over the layers, which is of prior importance for dynamic networks. This paper aims to overcome the main limitations of the multislice modularity by introducing a new formulation of modularity for multi- layer networks. We revise the role and semantics of both the resolu- tion and inter-layer coupling factors based on information available from the within-layer and inter-layer structures of the multilayer communities. Also, our proposed multilayer modularity is general enough to consider orderings of network layers and their constraints on layer coupling. Exper- iments were carried out on synthetic and real-world multilayer networks using state-of-the-art approaches for multilayer community detection. The obtained results have shown the meaningfulness of the proposed modu- larity, revealing the effects of different combinations of the resolution and inter-layer coupling functions. This work also represents a starting point for the development of new optimization methods for community detec- tion in multilayer networks. ∗ Accepted for publication with IEEE Trans. on Network Science and Engineering, April 2019. DOI: 10.1109/TNSE.2019.2913325 † ‡ An abridged version of this work appeared in [1]. Corresponding author: Andrea Tagarelli. 1 1 Introduction Complex network systems, such as social networks, biological networks, and transportation networks, are inherently organized into communities, a.k.a. clus- ters or modules, with dense internal links and sparse external links. Since mem- bers of a community tend to generally share common properties, revealing the community structure in a network can provide a better understanding of the overall functioning of the network. The well-known modularity [2, 3] function was originally conceived to evalu- ate a community structure in a network graph in terms of difference between the actual number of edges linking nodes inside each community and the expected connectivity in the null model. Typically, the expected connectivity is expressed through a configuration graph model, having a certain degree distribution and randomized edges. Since this graph ignores any community structure, a large difference between actual connectivity and expected connectivity would indicate the presence of a community structure. Modularity has been widely utilized as objective function in several optimiza- tion methods designed for discovering communities in networks [4, 5], including greedy agglomeration [3, 6], spectral division [7, 8], simulated annealing [9], or extremal optimization [10]. Traditional approach to network analysis refers to the modeling of a real- world system as a single network of interacting entities. While this approach has been widely used to study a variety of applications, there are plenty of scenar- ios for which this methodology appears strongly limiting [11]. In general, ties among entities could be induced by one or several types of relations or interac- tions, or even be dependent on side-information based on specific dimensions or aspects of interest for the entities in the network. Within this view, multilayer networks [12, 13] represent a powerful tool to model systems interconnected by multiple types of relations. In the multilayer network model, each type of con- nection is represented by a layer, and an entity may be present in different layers based on the type of relations it is connected to its neighbor entities. Just to mention one real example, nowadays online users usually have multiple accounts across different online social networks, and several online/offline relationships are likely to occur among the same group of individuals (e.g., following rela- tions, like/comment interactions, working together, having lunch). It should be emphasized that neglecting such a kind of complex organization by reducing the whole system to a single network (e.g., through some kind of projection, or by aggregation), has been shown to be much less informative than the multilayer representation [14]. For the above mentioned reasons, multilayer networks are experiencing an increasing interest from the scientific community, leading to an explosion of scientific papers in many areas of science, thus becoming one of the most used tools for interdisciplinary research [15], [16], [11], [13], [17], [18], [12], [19], [20, 21], [22], [23]. Clearly, the problem of community detection in such multilayer networks takes a central role to unveil meaningful patterns of node groupings into com- munities, by leveraging the various interaction modes that involve all the entity nodes in the network. To address these needs, modularity has been extended to the general case of multilayer networks. In particular, Mucha et al. [15] extend the modularity function to arbitrary multilayer networks (also called multislice in that work), by introducing two additional parameters w.r.t. classic modular- ity: a resolution parameter and an inter-layer coupling factor. The resolution parameter acts on the expected connectivity terms, thus controlling the effect on the size distribution of community due to the resolution limit known in mod- ularity [24]. The inter-layer coupling factor focuses on the links across layers and hence impacts on the strength of the inter-layer connections of entities in the network. While being important to enhance the ability of modularity in evaluating a community structure, the two parameters introduced in the mul- tislice modularity are nonetheless subjected to arbitrary choices, which raise a number of issues in the application of this modularity function. In particular, the resolution parameter can be arbitrarily set for each layer, but it discards any structure information at graph or community level. Moreover, the inter-layer coupling terms do not differentiate among the selected layers, and all pairs of layers can in principle be considered, which makes no sense in certain scenarios such as modeling of time-evolving networks. The above considerations prompted us to revisit the notion of modularity in multilayer networks, and in particular to introduce novel aspects to take into account in both the resolution and inter-layer coupling definitions. First, the layer-specific resolution factor is also made dependent on each particular com- munity. We notice that, since a high-quality multilayer community should em- bed high information content among its nodes, the resolution of a specific layer to control the expected connectivity of a given community in the modularity function should be lower as the contribution of that layer to the information content of the community is higher. By relating the information content of a multilayer community to the amount and variety of types of links internal to the community, we provide a new definition of resolution factor based on the concept of redundancy of community. Second, to determine the strength of coupling of nodes across layers, we again consider it at community level, such that for each pair of layers, the inter-layer coupling factor for nodes in a community depends on the relevance of the community projection on the two layers. Moreover, we account for an available ordering of the layers, and relating constraints on their coupling validity. Our main contributions are summarized as follows: • We propose a novel definition of multilayer modularity, in which we recon- sider the role and semantics of its two key terms, that is, the resolution factor and inter-layer coupling factor. We conceive parameter-free un- supervised approaches for their computation, which leverage information from the within-layer and across-layer structures of the communities in the multilayer network. Moreover, our formulation of multilayer modu- larity is general enough to account for an available ordering of the layers, therefore is also well-suited to deal with temporal multilayer networks. • We provide theoretical insights into properties of the proposed multilayer modularity. More specifically, we investigate the effect of increasing the number of communities in the behavior of the multilayer modularity, and we analytically derive the lower and upper bounds in the values of the multilayer modularity. • We conduct an extensive experimental evaluation, primarily to understand how the proposed multilayer modularity behaves w.r.t. different settings regarding the resolution and the inter-layer coupling terms. Using 4 state- of-the-art methods for multilayer community detection (GL, PMM, LART, and M-EMCD∗), LFR synthetic multilayer networks and 10 real-world multilayer networks, results have shown the significance of our formulation and the different expressiveness against the previously existing multislice modularity. 2 Related Work Community detection is a key-enabling task in network analysis and mining, with tons of methods developed in the last ten years -- please refer to [25, 26, 16, 27] for surveys on this topic. In addition, different metrics for community structure evaluation have been introduced. As discussed in Section 1, the most popular and widely accepted measure is the so-called "modularity", defined by Newman [2]. Initially conceived for undirected networks, the modularity function has been subsequently extended to cover different cases. In [28][29], modularity has been generalized to directed networks incorporating information contained in edge directions, while in [30] modularity is also adapted to capture communities in weighted networks. To overcome the well-known modularity resolution limit [24, 31, 32], in [33] and [34] modularity has been modified by incorporating a resolution parameter that helps reveal communities at different resolution scale. A further step towards a generalization of the modularity refers to its extension to signed networks [35, 36]. Also, to deal with bipartite net- works, modifications have been proposed in [37, 38, 39]. To uncover overlapping communities, in [40] the authors propose an extension to the modularity func- tion that includes the notion of belonging (or membership) coefficient, which measures to which extent a node belongs to the various communities. This approach is sometimes referred to as fuzzy community discovering. Finally, as introduced in Section 1, modularity has been generalized by [15] to capture communities in multislice networks. Such a version of the modularity function is detailed in the next section. 3 Background 3.1 Modularity Given an undirected graph G = (V,E), with n = V nodes and m = E edges, let C be a community structure over G. For any v ∈ V, we use d(v) to denote the of C, i.e., d(C) = (cid:80) graph, d(V), is defined as d(V) = (cid:80) degree of v, and for any community C ∈ C, symbol d(C) to denote the degree v∈C d(v); also, the total degree of nodes over the entire C∈C d(C) = 2m. Moreover, we denote with dint(C) the internal degree of C, i.e., the portion of d(C) that corresponds to the number of edges linking nodes in C to other nodes in C. Newman and Girvan's modularity is defined as follows [2]: v∈V d(v) = (cid:80) (cid:18) d(C) (cid:19)2 QN G(C) = dint(C) d(V) − d(V) (1) (cid:88) C∈C In the above equation, the first term is maximized when many edges are contained in clusters, whereas the second term is minimized by partitioning the graph into many clusters with small total degrees. The value of QN G ranges within -0.5 and 1.0 [4]; it is minimum for any bipartite network with canonic clustering, and maximum when the network is composed by disjoint cliques. 3.2 Multilayer network model Let GL = (VL, EL,V,L) be a multilayer network graph, where V is a set of entities and L = {L1, . . . , L(cid:96)} is a set of layers. Each layer represents a specific type of relation between entity nodes. Let VL ⊆ V × L be the set containing the entity-layer combinations, i.e., the occurrences of each entity in the layers. EL ⊆ VL×VL is the set of undirected links connecting the entity-layer elements. For every Li ∈ L, we define Vi = {v ∈ V (v, Li) ∈ VL} ⊆ V as the set of nodes in the graph of Li, and Ei ⊆ Vi × Vi as the set of edges in Li. Each entity must i=1..(cid:96) Vi = V, but each layer is not required to contain all elements of V. We assume that the inter-layer links only connect the same entity in different layers, however each entity in one layer could be linked to the same entity in a few or all other layers. be present in at least one layer, i.e.,(cid:83) 3.3 Multislice Modularity Given a community structure C identified over a multilayer network GL, the multislice modularity [15] of C is defined as: (cid:19) (cid:20)(cid:18) (cid:88) u,v, Li,Lj Qms(C) = 1 d(VL) AuvLi − γi dLi(u)dLi(v) 2Ei (cid:3) δ(gu,Li , gv,Lj ) × (2) × δLi,Lj + δu,vCv,Li,Lj where d(VL) is the total degree of the multilayer network graph, dLi (u) denotes the degree of node u in layer Li, AuvLi denotes a link between u and v in Li, 2Ei is the total degree of the graph of layer Li, γi is the resolution parameter for layer Li, Cv,Li,Lj quantifies the links of node v across layers Li, Lj. Moreover, the Dirichlet terms have the following meanings: δLi,Lj is equal to 1 if Li = Lj and 0 otherwise, δu,v is equal to 1 if u = v and 0 otherwise (i.e., the inter- layer coupling is allowed only for nodes corresponding to the same entity), and δ(gu,Li, gv,Lj ) is equal to 1 if the community assignments of node u in Li and node v in Lj are the same and 0 otherwise. Limitations of Qms. As previously mentioned, a different resolution parame- ter γi can be associated with each layer to express its relevance weight; however, in [15], there is no specification of any principled way to set a layer-weighting scheme, possibly including information from the available multilayer community structure. Moreover, neither the inter-layer coupling term (i.e., Cv,Li,Lj ) or any constraint on the layer comparability are clearly defined; actually, all nonzero inter-layer edges are set to a constant value ω, for all unordered pairs of layers. In general, both γi and ω parameters can assume any non-negative value, which further increases a clarity issue in the properties of Qms. 4 Proposed Multilayer Modularity In this section, we propose a new definition of modularity for multilayer networks that aims to overcome all of the issues of Qms previously discussed. We pursue this goal by focusing on the role and semantics of the two key elements in multilayer modularity: the layer-specific resolution and the inter-layer coupling. Our definitions of the two terms are independent on a-priori assumptions on the network and/or user-specified settings; by contrast, we conceive parameter- free unsupervised approaches for their computation, by leveraging information from the within-layer and inter-layer structures of the communities. Our pro- posed resolution factor is computed for pairs of layer and community, rather than for each layer globally. Analogously, to define the inter-layer coupling term, we account for properties related to a community on two layers; more in detail, we evaluate the projections of a community over any two comparable layers, i.e., the sets of nodes belonging to a community that lay on those layers. Remarkably, the comparability of layers is another key aspect of our definition of modularity: we generalize the inter-layer coupling term by admitting the exis- tence of a partial order relation ≺L over the layers, in order to properly represent scenarios in which a particular ordering among layers is required. For instance, it may be the case that the network layers have to be processed according to their natural order (e.g., lexicographic order of the network labels), or according to a temporal order; moreover, it may be required to compare adjacent layers only, or each layer with any other succeeding it in the ordering. Figure 1 pro- vides an illustration of a multilayer network and the aforementioned key aspects we deal with in our proposed multilayer modularity, which is formally presented next. Definition 4.1 (Multilayer Modularity). Let GL = (VL, EL,V,L) be a multi- layer network graph, and let ≺L be an optionally provided partial order relation over the set of layers L. Given a community structure C = {C1, . . . , Ck} as a Figure 1: Example multilayer network. The ordering over the set of layers enables the introduction of constraints to compare layers; for instance, adjacent- layer coupling forces the comparison of adjacent layers only, while succeeding- layer coupling allows each layer to be compared with the subsequent ones. Note also that any community across the layers is visually represented by means of each projection from one layer to another valid layer; for instance, using succeeding-layer coupling, community C3 in layer L1 is projected onto layer L2 and layer L3. partitioning of the multilayer graph GL, the multilayer modularity is defined as: • P(L) is the set of valid pairings with L defined as: (cid:40){L(cid:48) ∈ L L ≺L L(cid:48)}, L \ {L}, P(L) = if ≺L is defined otherwise (cid:3) (cid:88) L(cid:48)∈P(L)  (cid:88) dint (cid:88) L∈L Q(C) = 1 d(VL) C∈C L (C) − γ(L, C) (dL(C))2 d(VL) + β IC(C, L, L(cid:48)) where for any C ∈ C and L ∈ L: (3) • dL(C) and dint L (C) are the degree of C and the internal degree of C, re- spectively, by considering only edges of layer L; • γ(L, C) is the value of the resolution function; • IC(C, L, L(cid:48)) is the value of the inter-layer coupling function for any valid layer pairings with L; • β ∈ {0, 1} is a parameter to control the exclusion /inclusion of inter-layer couplings; and +Succeeding-layer coupling Adjacent layer coupling layer ordering axis C1 (1) C1 (2) C1 (3) L1 L2 L3 C3 (3) C3 (2) C3 (1) Notably, unlike the multislice modularity in Eq. (2), our proposed modularity originally introduces a resolution factor that varies with each community, and an inter-layer coupling scheme that might also depend on the layer ordering. Moreover, Eq. (3) utilizes the total degree d(VL) of the multilayer graph instead of the layer-specific degree (i.e., term 2ELi, for each Li ∈ L). The latter difference w.r.t. the multislice modularity is also important because, as we shall later discuss more in detail, the total degree of the multilayer graph includes the inter-layer couplings and it might be defined in different ways depending on the scheme of inter-layer coupling. In the following, we elaborate on the resolution functional term, γ(·,·), and the inter-layer coupling functional term, IC(·,·,·). 4.1 Redundancy-based resolution factor The layer-specific resolution factor intuitively expresses the relevance of a par- ticular layer to the calculation of the expected community connectivity in that layer. While this can always reflect some predetermined scheme of relevance weighting of layers, we propose a more general definition that accounts for the strength of the contribution that a layer takes in determining the internal con- nectivity for each community. The key assumption underlying our approach is that, since a high quality community should envelope high information content among its elements, the resolution of a layer to control the expected connectiv- ity of a given community should be lowered as the layer's contribution to the information content of the community increases. In this regard, the redundancy measure proposed in [41] is particularly suited to quantify the variety of connections, such that it is higher if edges of more types (layers) connect each pair of nodes in the community. Let us denote with P1 the set of node pairs connected in at least one layer in the graph, and with P2 the set of "redundant" pairs, i.e., the pairs of nodes connected in at least two layers. Given a community C, P C 2 denote the subset of P1 and the subset of P2, respectively, corresponding to nodes in C. The redundancy of C, ρ(C), expresses the number of pairs in C with redundant connections, divided by the number of layers connecting the pairs. Formally [41]: 1 and P C (cid:88) ρ(C) = (v,u)∈P C 2 SL(v, u,L) L×P C 1 , (4) with SL(v, u,L) = {L ∈ L (v, u, L) ∈ EL}. Note that in the above formula, each of the sets SL refers to the layers on which two nodes in a redundant pair are linked. Upon this concept, we define the set of supporting layers sup for each community C as: sup(C,L) = SL(v, u,L). (5) Using the above defined sup(C,L), we provide the following definition of redundancy-based resolution factor. (v,u)∈P C 2 (cid:91) Figure 2: Multilayer network for our running example Definition 4.2 (Redundancy-based resolution factor). Given a layer L and a community C, the redundancy-based resolution factor in Eq. (3) is defined as: γ(L, C) = 2 1 + log2(1 + nrp(L, C)) (6) where nrp(L, C) = {s=SL(v, u,L) ∈ sup(C,L) L ∈ s} expresses the number (cid:3) of times layer L participates in redundant pairs. Note that γ(L, C) ranges in (0, 1]∪[2]. In particular, it ranges in (0, 1] as long as L participates in at least one redundant pair, and it decreases as nrp(L, C) increases; moreover, as special case, γ(L, C) is equal to 2 when nrp(L, C) = 0. Example 4.1. Consider the network with 16 entities and 5 layers shown in Fig. 2, and let us first focus on some specific cases for the computation of the γ(L, C) terms. For instance, given community C4 and layers L1 and L5, the cor- responding values of redundancy-based resolution are equal to 2, because L1, L5 never participate in redundant pairs for nodes of C4. By contrast, layers L2 and L5 participate in one redundant pair for community C1, which corresponds to 1 3 2 4 5 8 6 9 11 10 12 7 C1 (1) C3 (1) 14 15 13 C2 (1) C4 (1) 1 2 4 5 8 6 9 11 10 C1 (2) C3 (2) C2 (2) 4 6 9 11 10 7 C3 (3) C2 (3) 1 3 2 4 5 6 9 11 10 16 C1 (4) C3 (4) C2 (4) 3 2 4 5 6 11 10 12 C1 (5) C3 (5) 14 15 C2 (5) C4 (5) 16 L1 L2 L3 L4 L5 Table 1: Redundancy-based resolution factor γ(L, C) for each community and layer of the example network in Fig. 2. L1 0.667 0.525 0.602 2.000 L2 1.000 0.558 0.667 - L3 - 0.667 0.667 - L4 0.667 0.667 0.602 - L5 1.000 0.667 0.558 2.000 C1 C2 C3 C4 the edge linking entities 2 and 3 for L5 and the edge linking entities 1 and 2 for L2; therefore, the values of redundancy-based resolution associated with C1 on L2 and L5 are equal to 1. Also, the resolution for C1 on L1 takes a value lower than 1 since there is more than one redundant pair. Table 1 reports on the entire set of values for the resolution factor computed on the network of Fig. 2. 4.2 Projection-based inter-layer couplings We propose a general and versatile approach to quantify the strength of coupling of nodes in one layer with nodes on another layer. Our key idea is to determine the fraction of nodes belonging to a community onto a layer that appears in the projection of the community on another layer, and express the relevance of this projection w.r.t. that pair of layers. Given a community C ∈ C and layers Li, Lj ∈ L, we will use symbols C (i) and C (j) to denote the projection of C onto the two layers, i.e., the set of nodes in C that lay on Li and Lj, respectively. In the following, we define two approaches for measuring inter-layer couplings based on community projection. For any two layers Li, Lj and community C, the first approach, we call symmetric, determines the relevance of inter-layer coupling of nodes belonging to C as proportional to the fraction of nodes shared between Li and Lj that belong to C. Definition 4.3. Given a community C ∈ C and layers Li, Lj ∈ L, the symmet- ric projection-based inter-layer coupling, denoted as ICs(C, Li, Lj) and referring to term IC in Eq. (3), is defined as the probability that C lays on Li and Lj: ICs(C, Li, Lj) = Pr[C in Li, C in Lj] = C (i) ∩ C (j) Vi ∩ Vj (7) (cid:3) The above definition assumes that the two events "C in Li" and "C in Lj" are independent to each other, and it does not consider that the coupling might have a different meaning depending on the relevance a community has on a particular layer in which it is located. By relevance of community, we simply mean here the fraction of nodes in a layer graph that belong to the community; therefore, the larger the community in a layer, the more relevant is w.r.t. that layer. However, we observe that more relevant community in a layer corresponds to less surprising projection from that layer to another. This would imply that the inter-layer coupling for that community is less interesting w.r.t. projections of smaller communities, and hence the strength of the coupling might be lowered. We capture the above intuition by the following definition of asymmetric projection-based inter-layer coupling. Definition 4.4. Given a community C ∈ C and layers Li, Lj ∈ L, the asym- metric projection-based inter-layer coupling, denoted as ICa(C, Li, Lj) and re- ferring to term IC in Eq. (3), is defined as the probability that C lays on Lj given that C lays on Li: ICa(C, Li, Lj) = Pr[C in LjC in Li] = Pr[C in Li, C in Lj] = = = Pr[C in Li] C (i) ∩ C (j) Vi ∩ Vj × Vi C (i) (8) (cid:3) Dealing with layer ordering. Our formulation of multilayer modularity is general enough to account for an available ordering of the layers, according to a given partial order relation. The previously defined asymmetric inter-layer coupling is well suited to model situations in which we might want to express the inter-layer coupling from a "source" layer to a "destination" layer. Given any two layers Li, Lj, it may be the case that only comparison of Li to Lj, or vice versa, is allowed. This is clearly motivated when there exist layer-coupling constraints, thus only some of the layer couplings should be considered in the computation of Q. In practical cases, we might assume that the layers can be naturally ordered to reflect a predetermined lexicographic order, which might be set, for instance, according to a progressive enumeration of layers or to a chronological order of the time-steps corresponding to the layers. That said, we can consider two special cases of layer ordering: • Adjacent layer coupling: Li ≺L Lj iff j = i + 1 according to a predeter- mined natural order. • Succeeding-layer coupling: Li ≺L Lj iff j > i according to a predetermined natural order. Note that the adjacent layer coupling scheme requires (cid:96) − 1 pairs to consider, while the succeeding-layer coupling scheme involves the comparison between a layer and its subsequent ones, i.e., ((cid:96)2 − (cid:96))/2 pairs. Moreover, it should be noted that the availability of a layer ordering enables two variants of the asymmetric projection-based inter-coupling given in Eq. (8). For any two layers Li, Lj ∈ L, such that Li ≺L Lj holds, we refer to as inner the direct evaluation of ICa(C, Li, Lj), and as outer the case in which Li and Lj are switched, i.e., ICa(C, Lj, Li). In the inner case, the strength of coupling is higher as the projection of C on the source layer (i.e., the preceding one in the order) is less relevant; vice versa, the outer case weights more the coupling as the projection on the destination layer (i.e., the subsequent one in the order) is less relevant. Example 4.2. Consider again the example network of Fig. 2. The asymmetric coupling for the projection of community C2 from L2 to L3 is ICa(C2, L2, L3) = (2/5) × (9/4) = 9/10 = 0.9 in the inner case, and ICa(C2, L3, L2) = (2/5) × (6/3) = 4/5 = 0.8 in the outer case. We hereinafter use symbols ICia and ICoa to distinguish between the inner asymmetric and the outer asymmetric evaluation cases. Time-evolving multilayer networks. So far we have assumed that when com- paring any two layers Li, Lj, with Li ≺L Lj, it does not matter the number of layers between Li and Lj. Intuitively, we might want to penalize the strength of the coupling as more "distant" Lj is from Li. This is often the case in time- sliced networks, whereby we want to understand how community structures evolve over time. In light of the above remarks, we define a refinement of the asymmetric projection-based inter-layer coupling, by introducing a multiplicative factor that smoothly decreases the value of the ICa function as the temporal distance be- tween Li and Lj increases. Definition 4.5. Given a community C ∈ C and layers Li, Lj ∈ L, such that Li ≺L Lj, the time-aware asymmetric projection-based inter-layer coupling, denoted as IC t a(C, Li, Lj), is defined as a(C, Li, Lj) = ICa(C, Li, Lj) × IC t 2 1 + log2(1 + j − i) (9) (cid:3) Note that the second term in the above equation is 1 for the adjacent layer coupling scheme, thus making no penalization effect when only consecutive lay- ers are considered. Example 4.3. Referring again to the example in Fig. 2, in Table 2 we sum- marize the mean and standard deviation values for the different variants of the inter-layer coupling factor. One remark is that the values for communities C2 and C3 are higher than those corresponding to communities C1 and C4. This is mainly due to the representativity of C2 and C3 in all layers. The lowest val- ues are obtained for community C4, which is in fact less represented than other communities (only in layers L1 and L5). For instance, let us focus on this com- munity. The mean inter-layer coupling factor IC Suc for community C4 is 0.11, since: C (5) 4 = 2, V5 ∩ V1= 10 (which is exactly the size of L5 without 4 ∩ C (1) oa Table 2: Different variants of the inter-layer coupling factor, for each community of the example network in Fig. 2. Values are cumulated over the admissible pairings of layers. Mean and standard deviation values are reported. ICs 0.135 ± 0.038 0.398 ± 0.096 0.416 ± 0.074 0.018 ± 0.000 C1 C2 C3 C4 ICia ≡ ICoa 0.612 ± 0.214 1.105 ± 0.284 1.148 ± 0.258 0.091 ± 0.000 IC Adj ia 0.444 ± 0.314 1.115 ± 0.157 1.188 ± 0.239 0.000 ± 0.000 IC Adj oa 0.525 ± 0.071 1.192 ± 0.320 1.088 ± 0.118 0.000 ± 0.000 IC Suc ia 0.619 ± 0.274 1.018 ± 0.245 1.249 ± 0.306 0.091 ± 0.000 IC Suc oa 0.606 ± 0.159 1.193 ± 0.305 1.048 ± 0.158 0.110 ± 0.000 Table 3: Multilayer modularity for the various combinations of resolution and inter-layer coupling terms, on the example network in Fig. 2. Community- specific values correspond to the modularity contribution given by each partic- ular community to the overall modularity. γ, IC Suc γ = 1, IC = 0 γ, IC Suc γ, IC = 0 γ = 1, ICs γ = 1, ICia γ = 1, ICoa γ, ICs 0.064 0.164 0.161 0.022 0.411 γ, ICia 0.098 0.214 0.213 0.028 0.554 γ, ICoa 0.098 0.214 0.213 0.028 0.554 C1 C2 C3 C4 Q γ, IC Adj ia 0.129 0.318 0.313 0.044 0.803 γ, IC Adj oa 0.131 0.320 0.309 0.044 0.804 ia 0.142 0.317 0.325 0.045 0.828 oa 0.141 0.329 0.312 0.045 0.827 0.126 0.310 0.266 0.048 0.750 0.063 0.162 0.160 0.022 0.408 0.097 0.213 0.212 0.027 0.550 0.097 0.213 0.212 0.027 0.550 0.123 0.307 0.299 0.047 0.777 4 = 2; this determines an inter-layer coupling factor node 16), V5= 11 and C (5) of 1.1, which is divided by the admissible pairings of layers, i.e., 10. On the contrary, the mean IC Adj for C4 is equal to zero, because the projection of this oa community is always empty when the adjacent coupling scheme is used. Finally, Table 3 reports the multilayer modularity values, including the com- munity-specific contributions. Note that, regardless of the settings of γ and IC factors, communities C2 and C3 obtain the highest values of modularity, which is mainly determined since they are disconnected from the rest of the graph at layer L3. In general, it should be noted that the contribution given by each community is consistent w.r.t. the various settings of γ and IC factors. Also, it is interest- ing to note that discarding the inter-layer couplings (IC = 0, which corresponds to the 9th and 13th columns) can lead to values of community-modularity and global modularity that tend to be much higher than the corresponding cases with IC (cid:54)= 0. This overestimation can also occur, though to a lesser extent, when fixing γ = 1 (13th column) vs. redundancy-based γ (9th column). Also, it is worth noting that using the redundancy-based resolution factor γ with unordered layers (2nd, 3rd and 4th columns) increases the community as well as global modularity vs. the same cases with γ = 1 (10th, 11th, and 12th columns). 4.2.1 Relations between the resolution and inter-layer coupling fac- tors Both factors take into consideration the network context, however they differ in that γ(L, C) considers a "global" multiplex context, whereas IC considers a "local" multiplex context. Intuitively, γ(L, C) is defined for each valid layer- community pair according to the status of the links among nodes in community C that lays on L versus their status on the other layers. By contrast, IC con- siders the status of the same community from one layer to another comparable layer. In terms of numerical comparison, when the size of the community structure tends to the number of nodes of the network, γ(L, C) tends to increase (i.e., to the maximum value of 2) while IC tends to decrease (i.e., to zero). 4.3 Properties of the proposed multilayer modularity We provide theoretical insights on Q, focusing on the effect of increase in the size of the community structure and on the analytical derivation of the range of values of Q. 4.3.1 Effect of increase in the number of communities We discuss the effect of increasing k (i.e., decreasing the average size of commu- nities in C) by distinguishing three configurations of Q: (i) symmetric inter-layer coupling, (ii) asymmetric inter-layer coupling, and (iii) ordered layers. In the first case, Q tends to have a monotonic decreasing trend. This is easily explained by the combination of three contingencies. The first one is an aver- age decrease in the internal degree dint L . The second contingency is an increase in the redundancy-based resolution factor γ: in fact, smaller communities cor- respond to lower probability of observing redundant pairs within communities over different layers; this decreases the logarithmic term in the resolution factor, which will progressively tend to 2 (maximum value). The third contingency is a decrease in the inter-layer coupling factor ICs, since the size of community intersection becomes increasingly smaller as the community size decreases. By contrast, when equipped with the asymmetric projection-based inter- layer coupling ICa, Q tends to differ from a monotonic decreasing trend because of the bias term Vi C(i) , which increases with communities of smaller size. In the third case (i.e., ordered layers), Q can again follow an increasing or decreasing trend. Recall that the term d(VL) includes the contribution of the inter-layer edges, which obviously are fewer when the layer couplings are order- dependent. A decrease in the number of inter-layer couplings also makes the decrease in the actual connectivity term (i.e., dint L (C) d(VL) ) slower as k increases, since d(VL) is smaller than in the unordered-layer contingency. Consequently, the inter-layer coupling term could compensate the actual connectivity term, which will result in increasing the value of Q. Finally, considering time-aware asymmetric inter-layer coupling, Q is more likely to follow a decreasing trend 1+log2(1+j−i) , which penalizes because of the effect due to the smoothing term ICa for any two no time-consecutive layers. Consequently, since the inter-layer coupling factor IC t a is smaller than ICa, Q could monotonically decrease despite Vi C(i) in IC t the bias term a. 2 4.3.2 Lower and upper bounds To determine the range of values of the basic modularity in simple graphs, the theoretical frameworks previously studied in [4] and [24] define two canonical structures to support the analytical computation of the minimum and maximum value of the modularity, respectively. More specifically, the former work proved that any bipartite graph with the canonical two-way clustering obtains the min- imum value of modularity, whereas the latter work proved that the maximum modularity is reached in a graph composed of disjoint cliques. Following the lead of the above works, here we provide theoretical results about the analytical derivation of the lower bound and upper bound of our proposed multilayer modularity. Proposition 1. Given a multilayer network GL = (VL, EL,V,L), with n = V, (cid:96) = L, and a community structure C for GL, the lower bound of Q is as follows: with η = 0 for ICs and η = 1 for ICa, and p =(cid:80) (n(cid:96) + 2p)2 + Q(C) = − n2(cid:96) 4(1 + η)p n2(n(cid:96) + 2p) , (10) L∈LP(L) is the total number of valid layer-pairings. Proof. Proof is reported in the Appendix. Proposition 2. Given a multilayer network GL = (VL, EL,V,L), with n = V, (cid:96) = L, and a community structure C for GL, the upper bound of Q is as follows: (cid:18) 1 2 2 − 1) ( n 2 − 1)(cid:96) + p ( n 2 − 1)(cid:96) ( n 2 − 1)(cid:96) + p ( n 1 2 (1 + η)p − γ(cid:96) (cid:21) (cid:19)2 + (11) (cid:34) Q(C) =2 with η = 0 for ICs and η = 1 for ICa, and p =(cid:80) 2 − 1)(cid:96) + n2p n2( n + of valid layer-pairings. Proof. Proof is reported in the Appendix. L∈LP(L) is the total number Note that, in the special case for β = 0, i.e., the inter-layer coupling factor is discarded, the lower bound of Q is Q(C) = − 1 (cid:96) . Analogously, the upper bound of Q is rewritten as: with γ = 2(1 + log2(1 + 2 −1) n 2 ( n 2 2(cid:96) − γ 2(cid:96) , Q(C) = ))−1. (12) (13) 5 Evaluation Methodology We discuss here the evaluation networks (Sect. 5.1), the multilayer community detection methods (Sect. 5.2), and the experimental settings (Sect. 5.3). 5.1 Datasets Our selection of network datasets was motivated to fulfill the reproducibility requirement: in fact, all of our evaluation datasets, including both real-world networks and synthetic generators, are publicly available. Moreover, we also took the opportunity of diversifying the choice of real-world networks by con- sidering various domains that are profitably modeled as multilayer networks. 5.1.1 Real-world network datasets We considered 10 real-world multilayer network datasets. AUCS [42, 43] de- scribes relationships among university employees: work together, lunch together, off-line friendship, friendship on Facebook, and coauthorship. EU-Air transport network [42] (EU-Air, for short) represents European airport connections con- sidering different airlines. FAO Trade network (FAO-Trade) [44] represents dif- ferent types of trade relationships among countries, obtained from FAO (Food and Agriculture Organization of the United Nations). FF-TW-YT (stands for FriendFeed, Twitter, and YouTube) [12] was built by exploiting the feature of FriendFeed as social media aggregator to align registered users who were also members of Twitter and YouTube. Flickr refers to the dataset studied in [45]. We used the corresponding timestamped interaction network whose links express "who puts a favorite-marking to a photo of whom". We extracted the layers on a month-basis and aggregated every six (or more) months. GH-SO-TW (stands for GitHub, StackOverflow and Twitter) [46] is another cross-platform network where edges express followships on Twitter and GitHub, and "who answers to whom" relations on StackOverflow. Higgs-Twitter [42] represents friendship, reply, mention, and retweet relations among Twitter users. London transport network [18] (London, for short) models three types of connections of train stations in London: underground lines, overground, and DLR. ObamaInIs- rael2013 [47] (Obama, for short) models retweet, mention, and reply relations of users of Twitter during Obama's visit to Israel in 2013. 7thGraders [18] (VC- Graders, for short) represents students involved in friendship, work together, and affinity relations in the class. Table 4 reports for each dataset, the size of set V, the number of edges in all layers, and the average coverage of node set Li∈L(Vi/V)). The table also shows basic, monoplex structural (i.e., 1/L(cid:80) statistics (degree, average path length, and clustering coefficient) for the layer graphs of each dataset. 5.1.2 Synthetic network datasets Besides the real-world network data, we generated four synthetic multilayer network datasets. Our goal was the evaluation of the multilayer modularity Q Table 4: Main characteristics of our evaluation network datasets. Mean and standard deviation over the layers are reported for degree, average path length, and clustering coefficient statistics. #layers avg. path degree #entities #edges (V) 61 417 214 6 407 789 019 55 140 456 631 369 620 3 588 318 346 74 836 17 071 325 2 944 592 16 070 185 441 2 281 259 4 061 960 29 518 ((cid:96)) 5 37 364 3 5 3 4 3 3 3 node set coverage 0.73 0.13 1.00 0.58 0.33 0.68 0.67 0.36 0.50 1.00 AUCS EU-Air FAO-Trade FF-TW-YT Flickr GH-SO-TW Higgs-Twitter London Obama VC-Graders 10.43 ± 4.91 6.26 ± 2.90 7.35±6.17 9.97 ± 7.27 23.15 ± 5.61 41.29 ± 45.09 18.28 ± 31.20 2.12 ± 0.16 4.27 ± 1.08 17.01 ± 6.85 length 2.43 ± 0.73 2.25 ± 0.34 2.43±0.39 4.18 ± 1.27 4.50 ± 0.60 3.66 ± 0.62 9.94 ± 9.30 11.89 ± 3.18 13.22 ± 4.49 1.66 ± 0.22 clustering coefficient 0.43 ± 0.097 0.07 ± 0.08 0.31±0.11 0.13 ± 0.09 0.04 ± 0.01 0.02 ± 0.01 0.003 ± 0.004 0.036 ± 0.032 0.001 ± 0.0005 0.61 ± 0.89 on different network models. Two out of the four networks are composed of 2 layers and 256 entities. In one network, hereinafter referred to as ER-ER, the two layers are Erdos-R´enyi (ER) random graphs. In the second network, dubbed LFR-ER, the first layer is generated by the Lancichinetti-Fortunato- Radicchi (LFR) benchmark, while the second layer is an Erdos-R´enyi random graph. The other two networks are composed of 4 layers and 128 nodes. Both networks are characterized by two Erdos-R´enyi layers and two layers built as Girvan-Newman (GN) graphs, but they differ in the layer ordering: GN-ER- GN-ER in the first network, and GN-ER-ER-GN in the second network. Moreover, mainly for purposes of efficiency evaluation, we generated a set of synthetic multilayer networks using the Lancichinetti-Fortunato-Radicchi (LFR) benchmark. In particular, single-layer network datasets were provided by the LFR benchmark using a variable number of nodes with steps of 128 until 1024. Also, the maximum and average node degrees were set to 16, and the mixing coefficient µ was set to 0.1. Each network dataset was characterized by four communities. From each of such networks, a multilayer network was created by replicating the LFR single-layer from 2 to 10. 5.2 Community detection methods We resorted to state-of-the-art methods for community detection in multilayer networks, which belong to the two major approaches, namely aggregation and direct methods. The former detect a community structure separately for each network layer, after that an aggregation mechanism is used to obtain the final community structure, while the latter directly work on the multilayer graph by optimizing a multilayer quality-assessment criterion. (Note that while it is possible to flatten the multilayer graph in order to apply on it any conventional community detection algorithm, this approach can be too simplistic, since, e.g., it would not permit to investigate about the temporal evolution of communities.) As exemplary methods of the aggregation approach, we used Principal Mod- ularity Maximization (PMM) [48] and Enhanced Modularity-driven Ensemble- based Multilayer Community Detection (M-EMCD∗) [20]. PMM aims to find a concise representation of features from the various layers (dimensions) through structural feature extraction and cross-dimension integration. Features from each dimension are first extracted via modularity maximization, then concate- nated and subjected to PCA to select the top eigenvectors, which represent possible community partitions. Using these eigenvectors, a low-dimensional em- bedding is computed to capture the principal patterns across all the dimensions of the network, finally a k-means on this embedding is carried out to discover a community structure. M-EMCD∗ is a parameter-free extension of the M- EMCD method proposed in [19]. Given an ensemble of community structures available for a multilayer network, M-EMCD optimizes a consensus objective function to discover a consensus solution with maximum modularity, subject to the constraint of being searched over a hypothetical space of consensus com- munity structures that are valid w.r.t. the input ensemble and topologically bounded by two baseline solutions. To detect the initial cluster memberships of nodes, M-EMCD utilizes a consensus or co-association matrix, which stores the fraction of clusterings in which any two nodes are assigned to the same cluster. To filter out noisy, irrelevant co-association, a user-specified threshold must be specified. Besides introducing flexibility in community assignments of nodes during the modularity optimization, M-EMCD∗ overcomes the limi- tation of setting such a parameter of minimum co-association, by providing a parameter-free identification of consensus clusters based on generative models for graph pruning. As for the direct methods, we resorted to Generalized Louvain (GL) [15] and Locally Adaptive Random Transitions (LART) [17]. GL extends the classic Louvain method using multislice modularity, so that each node-layer tuple is assigned separately to a community. Majority voting is adopted to decide the final assignment of an entity node to the community that contains the major- ity of its layer-specific instances. LART is a random-walk based method. It first runs a different random walk for each layer, then a dissimilarity measure between nodes is obtained leveraging the per-layer transition probabilities. A hierarchical clustering method is used to produce a hierarchy of communities which is eventually cut at the level corresponding to the best value of multislice modularity. It should be emphasized that we selected the above methods because, while having different characteristics, they all use modularity either as optimization criterion (GL, PMM and M-EMCD∗) or as evaluation criterion to produce the final community structure (LART). Note also that PMM requires the desired number of communities (k) as input. Due to different size of our evaluation datasets, we devised several con- figurations of variation of parameter k in PMM, by reasonably adapting each of the configuration range and increment step to the network size. Concerning M- EMCD∗, we used the marginal likelihood filter (MLF) to perform parameter-free detection of the number of communities [20]. It should be noted that the selected methods actually discover different com- munity structures, thus supporting our choice in terms of diversity of evaluation scenarios for the two competing modularity measures under study. Table 5 re- AUCS EU-Air FAO-Trade FF-TW-YT GH-SO-TW Flickr Higgs-Twitter London Obama GL 5 10 12 749 87 12290 15218 21 297062 27 381 - - - - - 339 - 6 2 5 10 10 10 10 10 30 10 2 13 39 11 115 392 7660 121 46 328367 16 Table 5: Number of communities found by GL, LART, PMM and M-EMCD∗ with MLF model-filter on the real-world network datasets LART PMM M-EMCD∗ VC-Graders 3 ports the number of communities of the solutions found by the various methods on the real-world network datasets. (The number of communities k in PMM is selected according to the solution with highest modularity value.) We found that GL tends to discover a high number of communities for larger networks (i.e., Flickr, Higgs-Twitter, FF-TW-YT, and Obama), and the size distribution of these communities (results not shown) is highly right-skewed on the larger networks, while it is moderately left-skewed on the remaining datasets. A simi- lar result can be observed in M-EMCD∗ for the different networks, although in Higgs-Twitter and FF-TW-YT (resp. GH-SO-TW ) the number of communities is much lower (resp. higher) than in GL. By contrast, the best performances of PMM usually correspond to a low and quite stable number of communities. Also, LART generally tends to produce much more communities than the other methods, on the networks for which it is able to discover communities. As a final general remark, we used the original implementations of the se- lected methods, based on the source code made available by the respective authors. We emphasize that it is beyond the goals of this work to make any performance improvement in the community detection methods under study, which hence are considered here with no intent of comparative evaluation and with all their limitations. (This justifies, in particular, the inability of LART in terminating the task for some network datasets.) 5.3 Experimental settings We carried out GL, PMM, LART and M-EMCD∗ methods on each of the net- work datasets and measured, for each community structure solution, our pro- posed multilayer modularity (Q) as well as the Mucha et al.'s multislice modu- larity (Qms). We evaluated Q using the redundancy-based resolution factor γ(L, C) with either the symmetric (ICs) or the asymmetric (ICa) projection-based inter-layer coupling. We also considered cases corresponding to ordered layers, using either the adjacent-layer scheme or the succeeding-layer scheme, and for both schemes Table 6: Multilayer modularity Q and multislice modularity Qms on GL com- munity structures of the four synthetic networks. γ = 1, γ, #comm. Qms by GL ICia ≡ ICoa β = 0 0.290 0.486 0.552 0.552 γ, ICs 0.258 0.434 0.471 0.471 γ, ICia ≡ ICoa 0.262 0.441 0.475 0.475 ER-ER LFR-ER GN-ER-GN-ER GN-ER-ER-GN 10 16 4 4 0.249 0.486 0.429 0.429 γ = 1, ICs 0.192 0.404 0.432 0.432 0.196 0.411 0.436 0.436 considering inner (ICia) as well as outer (ICoa) asymmetric coupling. We fur- ther evaluated the case of temporal ordering, using the time-aware asymmetric projection-based inter-layer coupling. Yet, we considered the particular setting of uniform resolution (i.e., γ(L, C) = 1, for each layer L and community C). fixing γ = 1, the second by varying γ and ω = 1 − γ [15]. As for Qms, we devised two settings: the first by varying ω within [0..2] while 6 Results We organize our main experimental results into two parts, depending on whether layer ordering was considered in the evaluation networks. Experiments were carried out on an Intel Core i7-3960X CPU @3.30GHz, 64GB RAM machine. 6.1 Evaluation with unordered layers 6.1.1 Synthetic network datasets Table 6 reports the multilayer modularity Q, multislice modularity Qms and number of communities obtained by the GL solution on the four synthetic net- works. One first remark is that using the redundancy-based resolution factor γ always leads to higher Q w.r.t. In particular, we observe gains up to 0.1 on ER-ER, 0.07 on LFR-ER, and 0.12 on GN-ER-GN-ER and GN-ER-ER-GN. the cases corresponding to γ fixed to 1. Another remark is that the fully combination of resolution and inter-layer coupling factors (i.e., rightmost two columns) tends to lower the value of Q w.r.t. the cases corresponding to varying γ with β = 0 (i.e., third last column); moreover, the asymmetric inter-layer coupling results in a higher Q w.r.t. the symmetric setting of IC. This would hint that when the normalization term in the Q equation accounts for the inter-layer couplings, this results in lowering the value of Q, which is turn smoother when the asymmetric setting is used. Comparing Q and Qms, it should be noted that the two measures behave consistently on ER-ER vs. LFR-ER, i.e., the presence of a layer with a (LFR) modular structure actually leads to an increase in both modularity measures w.r.t. ER-ER. By contrast, Q tends increase faster than Qms on the two GN- ER networks: this can be explained since a higher number of layers (as occurs Table 7: Multilayer modularity Q on GL community structures γ(L, C) γ = 1 ICa 0.41 0.04 0.11 0.50 0.32 0.40 0.15 0.35 0.43 0.54 ICs 0.37 0.03 0.03 0.42 0.31 0.40 0.13 0.26 0.32 0.53 ICa 0.39 0.04 0.11 0.42 0.28 0.35 0.14 0.34 0.43 0.44 ICs 0.35 0.03 0.03 0.34 0.27 0.35 0.12 0.26 0.32 0.43 AUCS EU-Air FAO-Trade FF-TW-YT Flickr GH-SO-TW Higgs-Twitter London Obama VC-Graders for the two GN-ER networks than for the ER-ER and LFR-ER networks) has a higher effect on the inter-layer coupling factor IC, which is not present in Qms. 6.1.2 Real-world network datasets Tables 7 -- 9 and Fig. 3 report Q measurements on the community structure solutions obtained by the various community detection methods. Concerning GL (Table 7), we observe that with the exception of GH-SO-TW on which effects on Q are equivalent, using ICa leads to higher Q than ICs. On average over all networks, using ICa yields an increment of 13.4% and 14.6% (with γ fixed to 1) w.r.t. the value of Q corresponding to ICs. This higher performance of Q due to ICa supports our initial hypothesis on the opportunity of asymmetric inter-layer coupling. It is also interesting to note that, when fixing γ to 1, Q decreases w.r.t. the setting with redundancy-based resolution γ(L, C) -- decrement of 11% and 12% using ICa and ICs, respectively. Table 8 shows results obtained from LART solutions. (Due to memory- resource and efficiency issues shown by the currently available implementation of LART, we are able to report results only on some networks). We observe that the relative performance difference between ICs and ICa settings is consistent with results found in the GL evaluation; this difference is even extreme (0.98 or 0.99) on EU-Air and London, which is likely due also to the different sizes of community structures detected by the two methods (cf. Sect. 5.2). Table 9 shows results obtained by M-EMCD∗ solutions. Also in this case, using ICa generally leads to better Q than ICs, regardless of the setting of γ. In particular, the observed increase is higher in VC-Graders and London (0.2), followed by AUCS (0.18) and Obama (0.13). Moreover, when fixing γ to 1, in most cases Q decreases (0.01-0.06) w.r.t. the setting with redundancy-based resolution γ(L, C). Figure 3 shows how Q varies in function of the number (k) of clusters given as input to PMM. One major remark is that Q tends to decrease as k increases. This holds consistently for the configuration of Q with symmetric inter-layer Table 8: Multilayer modularity Q on LART community structures γ(L, C) γ = 1 ICa 0.47 1.00 1.00 0.30 ICs 0.19 0.02 0.01 0.28 ICa 0.43 1.00 1.00 0.22 ICs 0.15 0.02 0.01 0.20 AUCS EU-Air London VC-Graders Table 9: Multilayer modularity Q on M-EMCD∗ community structures γ(L, C) γ = 1 ICa 0.51 0.20 0.02 0.47 0.37 0.64 0.58 0.46 0.42 0.52 ICs 0.33 0.14 0.03 0.41 0.35 0.63 0.58 0.26 0.29 0.32 ICa 0.50 0.20 0.02 0.47 0.31 0.61 0.52 0.46 0.42 0.50 ICs 0.32 0.14 0.03 0.41 0.29 0.60 0.52 0.25 0.29 0.30 AUCS EU-Air FAO-Trade FF-TW-YT Flickr GH-SO-TW Higgs-Twitter London Obama VC-Graders coupling; in fact, as discussed in Sect. 4.3.1, the decrease of Q for increasing k depends on a combination of decrease of the internal degree dint L , decrease of the symmetric inter-layer coupling factor ICs, and increase of the redundancy- based resolution factor γ(L, C). Moreover, values of Q corresponding to ICa tend to be close to the ones obtained for ICs on the large networks, while on the smaller ones, ICa trends are above ICs, by diverging for high k in some cases; in particular, in London modularity for ICa follows a rapidly, roughly linear increasing trend with k; even more evident is the divergence of the ICs and ICa trends for AUCS. Again, as we previously discussed in Sect. 4.3.1, this is Vi due to the bias term C(i) of ICa, which increases with communities of smaller size. Note that, from an inspection of the behavior of Q for higher regimes of k, we also found that Q values eventually tend to stabilize below 1. As concerns the setting with γ fixed to 1 (results not shown), while the trends of Q for ICa and for ICs do not change significantly, the values are typically lower than those obtained with redundancy-based resolution, which is again consistent with results observed for GL, LART and M-EMCD∗ evaluations. Correlation analysis. We investigated whether any correlation may exist at community-level between the value of Q and selected statistics based on structural characteristics of the input network. For this purpose, we focused on the average path length, clustering coefficient, redundancy, and node- and edge-set coverage, for each community in an evaluation network; note that the latter two statistics are computed as, given a community C, the fraction of (a) AUCS (b) FF-TW-YT (c) Flickr (d) London (e) Obama (f) VC-Graders Figure 3: Multilayer modularity Q on PMM community structure solutions nodes (resp. edges) in a layer Li that belong to C, averaged over all layers in the network. Figure 4 shows the correlation between each of the above structural charac- teristics and the values of Q, with redundancy-based resolution factor γ(L, C) and ICs, on the solution found on selected networks by GL, M-EMCD∗ and PMM; for the latter, k was chosen as that corresponding to the best modularity performance. Note also that the correlation results obtained by Q with γ = 1 and ICs, γ = 1 and ICa, γ(L, C) only, and combination of γ(L, C) and ICa, do not show significant differences, hence their presentation is discarded. Looking at the three plots in the figure, we observe a mid-high positive correlation of Q with the topological measures in most cases. More in detail, in Fig. 4 (a) the modularity of the solution found by GL on EU-Air shows an average cor- relation of 0.85 with the other measures. Also, an average correlation of 0.95 and 0.96 is obtained between Q and respectively node-set and edge-set coverage on FF-TW-YT. For AUCS, Q has a positive correlation of 0.76 with clustering coefficient and a negative correlation with the other measures. For VC-Graders, Q shows a positive correlation with all measures except with redundancy. For London and GH-SO-TW, the correlation is up to 0.5. For FAO-Trade, Q shows a higher correlation up to 1 with node-set and edge-set coverage, and a lower correlation up to 0.5 with average path length, clustering coefficient and re- dundancy. Considering Fig. 4 (b), the multilayer modularity Q of the solution found by PMM shows an average correlation of 0.99 with clustering coefficient for EU-Air, of 1 and 0.92 with average path length, node-set and edge-set cov- erage for AUCS and FF-TW-YT, respectively, and of 1 with redundancy for VC-Graders. On the contrary, a correlation of -1 is obtained between Q and the clustering coefficient and redundancy for AUCS, and between Q and all 26101418k0.10.20.30.40.5Q(, ICa) (, ICs)105090250450k00.10.20.3Q(, ICa) (, ICs)105090250450k00.10.20.30.4Q(, ICa) (, ICs)5203550658095k00.20.40.60.8Q(, ICa) (, ICs)105090200k0.10.150.2Q(, ICa) (, ICs)246810k0.10.20.30.40.5Q(, ICa) (, ICs) (a) (b) (c) Figure 4: Pearson correlation coefficient between average path length (APL), clustering coefficient (CC), node-set coverage (NC), edge-set coverage (EC), and redundancy (RED) and the multilayer modularity Q with γ(L, C) and ICs computed on the solution found by (a) GL, (b) PMM, and (c) M-EMCD∗ for selected networks. Each statistic is computed at community-level measures except the redundancy for VC-Graders. For FAO-Trade, Q shows a positive correlation up to 1 with average path length, node-set and edge-set coverage, and a negative correlation up to -1 with the redundancy. A weakly negative correlation is shown between Q and clustering coefficient. In the other cases, the correlation ranges between -0.5 and 0.5. Finally, considering Fig. 4 (c), the multilayer modularity Q of the solution found by M-EMCD∗ shows a very high correlation with node-set and edge-set coverage in all networks. Also, Q shows a correlation with the average path length which is up to 0.5 in all networks, with the only exception of EU-Air and GH-SO-TW. For redundancy and clustering coefficient, Q obtains a high correlation with clustering coefficient and redundancy in FAO-Trade and with clustering coefficient in VC-Graders. Figure 5 shows the correlation between various settings of Q and the previ- ously analyzed set of statistics for solutions obtained by LART. Looking at the Air AUCS VCG London FFTW GHSOFAO-1-0.500.51CorrelationAPL CC NC EC RED Air AUCS VCG London FFTW GHSOFAO-1-0.500.51CorrelationAPL CC NC EC RED Air AUCS VCG London FFTW GHSOFAO00.51CorrelationAPL CC NC EC RED (a) (b) (c) Figure 5: Pearson correlation coefficient between average path length (APL), clustering coefficient (CC), node-set coverage (NC), edge-set coverage (EC), and redundancy (RED) and the multilayer modularity Q with: (a) γ(L, C), (b) γ(L, C) and ICs, and (c) γ(L, C) and ICa computed on the solution found by LART for the different real-world network datasets. Each statistics is computed at community-level plots, Q obtains the highest correlation with the edge-set coverage, followed by the node-set coverage, clustering coefficient and redundancy. Overall, results by LART confirm the trends observed for GL and PMM, with even higher tendency to positive correlation in general. Remarkably, this particularly holds when Q involves the inter-layer coupling terms, with ICa leading to higher correlation than ICs. 6.2 Evaluation with ordered layers In this section we focus on evaluation scenarios that correspond to the spec- ification of an ordering of the set of layers. We will present results on the real-world networks EU-Air and Flickr. The former was chosen because of its highest dimensionality (i.e., number of layers) over all datasets, the latter is a time-evolving multilayer network and was chosen for evaluating the time-aware asymmetric inter-layer coupling. Table 10 summarizes results by GL, LART and M-EMCD∗ on EU-Air, corre- Air AUCS VCG London 00.51CorrelationAPL CC NC EC REDAir AUCS VCG London 00.51CorrelationAPL CC NC EC REDAir AUCS VCG London 00.51CorrelationAPL CC NC EC RED Table 10: Multilayer modularity Q, with layer ordering, from GL, LART and M-EMCD∗ community structures, on EU-Air γ(L, C) γ = 1 IC Suc ia 0.786 0.981 0.997 IC Suc oa 0.734 0.972 0.998 ia IC Adj 0.512 0.665 0.970 IC Adj oa 0.511 0.656 0.969 IC Suc ia 0.783 0.981 0.997 IC Suc oa 0.729 0.972 0.999 ia IC Adj 0.504 0.664 0.974 IC Adj oa 0.503 0.656 0.973 GL LART M-EMCD∗ (a) EU-Air (ascend.) (b) Flickr Figure 6: Multilayer modularity Q of PMM solutions with layer ordering. (a) (c) (b) (d) Figure 7: Pearson correlation coefficient between average path length (APL), clustering coefficient (CC), node coverage (NC), edge coverage (EC), redun- dancy (RED), and the multilayer modularity Q with γ(L, C) and IC Adj ia , IC Adj oa , IC Suc oa , and ascendent layer ordering, computed on the solution found by (a) GL, (b) LART, (c) PMM, and (d) M-EMCD∗ on the EU-Air network. Each statistics is computed at community-level ia , IC Suc sponding to adjacent and succeeding-layer coupling. We observe that, regardless of the setting of the resolution factor, values of Q with succeeding-layer coupling 525507090k0.20.40.60.81QICAdjia ICAdjoa ICSucia ICSucoa 105090250450k00.10.20.30.4Q(, ICtia)(, ICtoa)(, ICia)(, ICoa)APL CC NC EC RED 00.250.50.751CorrelationICiaAdj ICoaAdj ICiaSuc ICoaSuc APL CC NC EC RED 00.250.50.751CorrelationICiaAdj ICoaAdj ICiaSuc ICoaSuc APL CC NC EC RED 00.250.50.751CorrelationICiaAdj ICoaAdj ICiaSuc ICoaSuc APL CC NC EC RED 00.250.50.751CorrelationICiaAdj ICoaAdj ICiaSuc ICoaSuc are higher than the corresponding ones for the adjacent layer coupling scheme. This suggests that the impact on the inter-layer coupling term is higher when all ordered pairs of layers are taken into account, than when only adjacent pairs are considered. In this regard, recall that the total degree of the multilayer graph, which normalizes the inter-layer coupling term as well, is properly computed according to the actual number of inter-layer couplings considered, depending on whether adjacent or succeeding-layer scheme was selected. The above result is also confirmed by PMM, as shown in Fig. 6, where the plots for the succeeding-layer scheme superiorly bound those for the adjacent scheme, over the various k. Note also that, while results on EU-Air are shown only for the ascendent layer ordering, by inverting this order we will have a switch between results corresponding to the inner asymmetric case with results corresponding to the outer asymmetric case. Moreover, Fig. 6(b) compares the effect of asymmetric inter-layer coupling on Flickr with and without time- awareness, for PMM solutions. Here we observe that both IC t oa plots are above those corresponding to ICia and ICoa. This indicates that considering a smoothing term for the temporal distance between layers (Eq. (9)) leads to an increase in modularity. This general result is also confirmed by GL, LART and M-EMCD∗ (results not shown); for instance, GL achieved on Flickr modularity 0.462 for IC t s, which compared to results shown in Table 7 represent increments in Q of 43%. Similarly, M-EMCD∗ obtained on Flickr modularity 0.975 for IC t s, which is higher than the corresponding values reported in Table 9 for ICa and ICs, respectively. Correlation analysis. Analogously to correlation analysis performed for the unordered case, we compare different settings of Q with selected statistics on topological properties. Figures 7 show results on EU-Air obtained by GL, LART, PMM and M-EMCD∗, respectively. Again, for PMM, k was set to the number of communities corresponding to the best modularity performance achieved by the method. oa, and 0.460 for IC t ia, 0.468 for IC t ia and IC t ia, IC t oa, and IC t As a general remark Q is always non-negatively correlated with all topo- logical measures. More specifically, the correlation is highly positive with all measures, when GL is used, and with all measures but average path length and clustering coefficient, when LART and M-EMCD∗ are used; for PMM, cor- relation is very high with clustering coefficient, and mid-low with the other measures. When equipped with succeeding-layer coupling, correlation is higher than in the adjacent-layer setting with average path length (up to +0.14), node- set coverage (up to +0.02) and redundancy (up to +0.05) for the solution found by GL and M-EMCD∗, and with average path length (up to +0.07), node-set coverage (up to +0.11) and edge-set coverage (up to +0.11) for the solution found by PMM. We also found that the layer ordering does not provide mean- ingful variations on the correlation values -- plots regarding descendent layer ordering are reported in the Appendix. (a) FF-TW-YT (b) Flickr (c) VC-Graders (d) FAO-Trade (e) AUCS (f) Higgs-Twitter (g) Obama (h) GH-SO-TW Figure 8: Mucha et al.'s modularity (Qms) by varying γ with ω = 1 − γ 6.3 Analysis of Qms and comparison with Q We discuss here performance results obtained by the community detection al- gorithms with Qms as assessment criterion. We will refer to the default setting of unordered set of layers as stated in [15]. Using GL, Qms tends to decrease as γ increases (while ω decreases, as it was varied with γ as ω = 1− γ). This occurs monotonically in most datasets, within positive ranges (e.g., from 0.636 to 0.384 on FF-TW-YT, from 0.525 to 0.391 on GH-SO-TW ) or including negative modularity for higher γ (e.g., from 0.645 -10Qms1.6250k10.8700.010-0.200.20.4-10Qms1.6250k10.8700.010-0.500.500.5Qms1.686k10.8420.00.20.40.6010Qms1.670k200.840100.024681012-200Qms1.614k200.8820.0-10-50-10Qms1.6250k10.8700.01000.20.4-500Qms1.6k500.890500.010-30-20-10010-0.50Qms1.6250k0.50.8700.01000.10.20.30.4 (a) FF-TW-YT (b) Flickr (c) FAO-Trade (d) AUCS (e) Higgs-Twitter (f) Obama Figure 9: Mucha et al.'s modularity (Qms) by varying ω with γ = 1 to -0.05 on Flickr, from 0.854 to -4 on AUCS ). Remarkably, the simultaneous effect of γ and ω = 1 − γ on Qms leads on some datasets (Obama, EU-Air, London) to a drastic degradation of modularity (down to much negative values) for some γ > 1, followed by a rapid increase to modularity of 1 as γ increases closely to 2. Analogous considerations hold for LART, PMM and M-EMCD∗. For the latter method, the trend of drastic degradation of modularity followed by a rapid increase is only visible for EU-Air. For PMM, the plots of Fig. 8 show results by varying k, on the real-world datasets. Surprisingly, it appears that Qms is relatively less sensitive to the variation in the community structure than our Q. This is particularly visible in AUCS, London (not shown), and Obama where Qms shows no variation for increasing k. Also, it is worth noting that, for specific values of γ, Qms may have an abrupt decrease with very low peaks, as it happens for Obama. By contrast, for FAO-Trade, a value around 0.8 for γ induces high modularity which is stable for the different k values. When varying ω within [0..2], with γ = 1, Qms tends to monotonically increase as ω increases. This holds consistently on all datasets (Fig. 9 shows plots for some of them) with the only exception of FAO-Trade, where Qms is 0Qms1.6250k0.50.8700.0100.10.20.30.400.5Qms1.6250k10.8700.0100.10.20.30.40.5-10Qms1.670k10.840100.000.20.40.60.800.5Qms1.614k10.8820.00.20.40.600.2Qms1.6250k0.40.8700.0100.10.20.300.5Qms1.6k10.890500.0100.20.40.60.8 Figure 10: Mucha et al.'s modularity (Qms) by varying γ with ω = 1 − γ and by varying ω with γ = 1, on the ground-truth community structure of AUCS. stable at 1 for ω > 0.8. Variations are always on positive intervals (e.g., from 0.248 to 0.621 on Flickr, from 0.305 to 0.541 on FF-TW-YT, from 0.136 to 0.356 on Higgs-Twitter ). 6.3.1 Comparison between Q and Qms: qualitative evaluation on the solutions generated by the community detection methods In the light of the above analysis, a few interesting remarks arise by observing the different behavior of Q and Qms over the same community structure solutions, in function of the resolution and inter-layer coupling factors. From a qualitative viewpoint, the effect of ω on Qms turns out to be opposite, in most cases, to the effect of our IC terms on Q: that is, accounting more for the inter- layer couplings leads to increase Qms, while this does not necessarily happen in Q. Less straightforward is comparing the use of a constant resolution for all layers, as done in Qms, and the use of variable (i.e., for each pair of layer and community) resolutions, as done in Q. In this regard, we have previously observed that the use of a varying redundancy-based resolution factor improves Q w.r.t. the setting γ = 1. By coupling this general remark with the results (not shown) of an inspection of the values of γ(L, C) in the computation of Q on the various network datasets (which confirmed that γ(L, C) values span over its range, in practice), we can conclude that a more appropriate consideration of the term modeling the expected connectivity of community is realized in our Q w.r.t. keeping the resolution as constant for all layers in Qms. 6.3.2 Comparison between Q and Qms: evaluation on AUCS ground- truth communities Let us now consider a further stage of evaluation of Q vs. Qms, which is com- plementary to the previous comparative analysis, with the specific purpose of assessing their behavior w.r.t. a ground-truth community structure. To this aim, we resorted again to the AUCS data: in their original work [43], the authors filled a gap in the literature (actually, still largely open) corresponding to a 00.511.52, -2-101Qms [0..2], =1- [0..2], =1 lack of benchmarks for understanding multilayer/multiplex networks. In that work, the authors also provided a ground-truth multiplex community struc- ture for AUCS, which reflects affiliation of the university employees/students to research groups. Please refer to [43] for a detailed description of how this ground-truth was obtained. In this context of evaluation, we analyzed again the behaviors of Q and Qms under particular settings of the resolution and inter-layer coupling factors, while keeping fixed the community structure to a reference one corresponding to ground-truth knowledge. Before going into details of such analysis, let us first provide some remarks on the trends of Qms under its two settings previously considered in Sect. 6.3: varying γ within [0..2] with ω = 1 − γ, and varying ω within [0..2] with γ = 1. As we observe from the results shown in Fig. 10, Qms can vary significantly depending on the setting of γ, ω: when γ = 1, ω ∈ [0..2], Qms monotonically increases with ω, varying within a relatively small range (i.e., from 0.38 to 0.76); however, when γ ∈ [0..2], ω = 1 − γ, Qms follows an inverse trend, with a more rapid decrease for γ > 1.5, and overall wider range (from 0.768 to -1.09). Note that these considerations on the trends are consistent with the previous analysis for Qms computed on the solution found by PMM for AUCS (cf. Figs. 8 -- 9 (e)). We shall come back later on such a high parameter-sensitivity of Qms. Table 11 shows the global and community-specific values of Q and Qms for particular combinations of their corresponding γ and inter-layer coupling factors (IC and ω, respectively). Columns 2 to 5 report basic structural statistics for each of the communities, while the rest of the table is organized into three subtables: the first refers to Qms results, the second to our Q, and the third again to Qms with Q-biased settings of γ, ω. In the latter case, we wanted to make Qms "closer to" Q by setting its parameters to the values of γ(L, C) and ICs, respectively, averaged over the different communities and layers. Moreover, note that ground-truth communities in AUCS are 14 in total, however we only reported results for those (7) that contain more than one node, in order to avoid cluttering the table with roughly constant, zero-close modularity values that correspond to the singleton communities. Looking at the table, communities C2 and C7 (resp. C5, C3, and C4) cor- lowest) modularity values, for either modularity respond to the highest (resp. measure, under each of the parameter-combinations considered. In general, be- yond the differences in the respective values of modularity (note that Qms values still differ from the corresponding Q ones even for the Q-biased settings), the two measures appear to behave similarly over the various communities. To con- firm this intuition, we evaluated the Pearson correlation of different pairings of Q and Qms community-specific values. Results show indeed almost perfect correlation (always above 0.98). One aspect of evaluation that we also investigated is whether disrupting the multiplex network by layer may have effect on the comparison between Q and Qms, which resembles a sort of layer-oriented resiliency analysis. More specif- ically, based on the structural impact due to the various layers in AUCS [43], we considered the following alternative configurations: (i) we removed layer co- 7 6 0 . 0 1 8 1 . 0 0 4 0 . 0 3 5 0 . 0 8 3 0 . 0 8 6 0 . 0 3 0 1 . 0 0 5 5 . 0 8 7 0 . 0 6 2 2 . 0 3 5 0 . 0 3 6 0 . 0 6 5 0 . 0 5 8 0 . 0 8 2 1 . 0 9 8 6 . 0 4 6 0 . 0 5 4 1 . 0 8 3 0 . 0 1 5 0 . 0 6 3 0 . 0 5 6 0 . 0 6 9 0 . 0 5 9 4 . 0 3 9 5 . 0 5 1 6 . 0 7 4 4 . 0 7 3 3 . 0 4 2 4 . 0 4 1 3 . 0 4 5 7 . 0 1 5 6 . 0 y t i r a l u d o m l a b o l G s C I g v a = ω 1 = ω s C I g v a = ω c u a S i C I j d a A i C I s m Q Q ) C , L ( γ g v a = γ 1 = γ ) C , L ( γ 1 = γ S C U A f o s e i t i n u m m o c h t u r t - d n u o r g n o t e l g n i s - n o n e h t f o h c a e r o f s m Q d n a Q f o s g n i t t e s c fi i c e p s n e e w t e b n o s i r a p m o C : 1 1 e l b a T 9 6 0 . 0 9 2 2 . 0 9 3 0 . 0 4 5 0 . 0 4 3 0 . 0 7 6 0 . 0 1 0 1 . 0 3 7 0 . 0 3 2 2 . 0 4 4 0 . 0 7 5 0 . 0 1 4 0 . 0 2 7 0 . 0 3 0 1 . 0 a i C I 4 5 0 . 0 8 4 1 . 0 6 3 0 . 0 4 4 0 . 0 5 3 0 . 0 5 5 0 . 0 5 7 0 . 0 s C I 8 3 0 . 0 5 3 1 . 0 0 2 0 . 0 9 2 0 . 0 8 1 0 . 0 7 3 0 . 0 8 5 0 . 0 a i C I 2 5 0 . 0 1 3 1 . 0 5 3 0 . 0 3 4 0 . 0 4 3 0 . 0 4 5 0 . 0 4 7 0 . 0 s C I 7 3 0 . 0 8 1 1 . 0 0 2 0 . 0 9 2 0 . 0 8 1 0 . 0 6 3 0 . 0 7 5 0 . 0 s m Q 1 = γ 2 = ω 1 = ω 3 8 0 . 0 9 3 2 . 0 1 6 0 . 0 9 6 0 . 0 6 6 0 . 0 5 9 0 . 0 1 4 1 . 0 6 7 0 . 0 2 0 2 . 0 2 5 0 . 0 2 6 0 . 0 4 5 0 . 0 3 8 0 . 0 3 2 1 . 0 . t s u l c . ff e o c 3 2 5 . 0 5 3 6 . 0 0 2 1 . 0 3 1 4 . 0 0 0 6 . 0 8 2 4 . 0 9 5 6 . 0 . g v a h t a p h t g n e l 1 8 0 . 1 4 6 5 . 1 8 4 1 . 1 8 3 0 . 1 3 3 1 . 1 8 0 2 . 1 1 5 5 . 1 e e r g e d s e g d e # . g v a / s e d o n # 0 0 0 . 3 3 5 8 . 4 0 1 2 . 1 5 0 1 . 2 0 0 1 . 2 0 3 4 . 2 0 7 5 . 3 8 / 4 9 2 / 1 1 4 / 6 6 / 5 4 / 3 8 / 6 3 1 / 7 1 C 2 C 3 C 4 C 5 C 6 C 7 C authorship (i.e., the smallest and less connected of all layers), (ii) we removed layers co-authorship and leisure (i.e., the ones having the lowest number of edges), (iii) we removed layer work (i.e., the one with the most edges), (iv) we retained layers work and lunch only. For each of such multiplex-disruption con- figurations, we replicated the above analysis corresponding to the full multiplex. Results (not shown) indicated no particular differences in terms of rankings of community modularity obtained by Qms and Q, respectively; however, we also observed a general decrease in Pearson correlation of the pairings of Qms and Q community-specific values, although the correlation remained still high, in par- ticular always above 0.96 (e.g., when removing layer work, correlation was 0.965 between Qms with γ = 1, ω = avg ICs and Q with γ = 1, ICs, and 0.98 between Qms with γ = avg γ(L, C), ω = avg ICs and Q with varying γ(L, C), ICs). To sum up, in this ground-truth evaluation, Qms and Q exhibited consis- tently similar behaviors at community level for specific settings of their respec- tive parameters of resolution and inter-layer coupling. However, it should be emphasized that such a similarity between the two modularity values was ac- tually achieved for either canonical settings of γ, ω in Qms (i.e., γ = 1 and ω ∈ {1, 2}) or Q-biased settings of γ, ω (i.e., γ = avg γ(L, C), ω = avg ICs). In general, Qms has shown to be highly sensitive to the settings of its parameters, whereas by contrast, our Q has the key advantage of automatically determining the resolution and inter-layer coupling factors based on the structural informa- tion of the communities in the multilayer network. 6.4 Efficiency evaluation We analyzed the computation time of Q for the different combinations of redun- dancy-based resolution factor γ and inter-layer coupling factors IC. The 3-D plots in Figs. 11 -- 12 display the time vs. the number of layers and the number of nodes per layer. For this analysis, we referred to the solutions found by GL for the multilayer networks generated through the LFR benchmark (cf. Section 5.1.2). As expected, the computation time increases with both the number of layers and nodes per layer, with the latter being less evident when setting γ fixed to 1. Also, while it is obvious that the computation time is higher when using variable (i.e., redundancy-based) resolution factor than in the case γ = 1 (with percentage increase of 50%, for the maximum number of layers and nodes per layer), we observe much less fluctuations in the plot surfaces than in the case of resolution factor fixed to 1, regardless of the setting of inter-layer coupling factors. The reader is also referred to the Appendix for further results by varying the inter-layer coupling settings. 7 Conclusion We proposed a new definition of modularity for multilayer networks. Motivated by the opportunity of revising the multislice modularity proposed in [15], we (a) β = 0 (b) ICs (c) ICia (d) ICoa Figure 11: Computation time (in seconds) of the multilayer modularity Q, with γ = 1, measured on the solution found by GL on the multiplex LFR network conceived alternative notions of layer resolution and inter-layer coupling, which are key-enabling for generalizations of modularity for multilayer networks. Us- ing four state-of-the-art methods for multilayer community detection, synthetic multilayer networks and ten real-world multilayer networks, we provided empir- ical evidence of the significance of our proposed modularity. Our work paves the way for the development of new optimization methods of community detection in multilayer networks which, by embedding our multilayer modularity, can discover community structures having the interesting proper- ties relating to the proposed per-layer/community redundancy-based resolution factors and projection-based inter-layer coupling schemes. In this respect, we point out that our multilayer modularity is able to cope with communities that are overlapping at entity level, which eventually reflect the different roles that the same entity can play when occurring in two or more layers of the network. Within this view, one benefit of adopting the multilayer network model is that the problem of computing soft community-memberships of entities can be trans- lated into a simpler problem of identification of crisp community-memberships of nodes within each layer. Nonetheless, a further interesting direction would (a) β = 0 (b) ICs (c) ICia (d) ICoa Figure 12: Computation time (in seconds) of the multilayer modularity Q, with redundancy-based γ(L, C), measured on the solution found by GL on the mul- tiplex LFR network be to evaluate our multilayer modularity in contexts of node-overlapping com- munities. In this case, however, one challenge to face is whether and to what extent an overlapping-aware multilayer modularity should be able to measure the community overlaps within each layer and/or across the layers. Along this direction, it would be interesting to study an integration of our multilayer mod- ularity into recently developed works that propose probabilistic representations or stochastic generative models for overlapping community detection in multi- layer networks [49, 50]. Acknowledgements This research work has been partly supported by the Start-(H)Open POR Grant No. J28C17000380006 funded by the Calabria Region Administration, and by the NextShop PON Grant No. F/050374/01-03/X32 funded by the Italian Min- istry for Economic Development. References [1] A. Amelio and A. Tagarelli, "Revisiting Resolution and Inter-Layer Cou- pling Factors in Modularity for Multilayer Networks," in Proc. IEEE/ACM ASONAM, 2017, pp. 266 -- 273. [2] M. E. J. Newman and M. Girvan, "Finding and evaluating community structure in networks," Phys. Rev. E, vol. 69, no. 2, p. 026113, 2004. [3] M. E. J. Newman, "Fast algorithm for detecting community structure in networks," Phys. Rev. E, vol. 69, 2004. [4] U. Brandes, D. Delling, M. Gaertler, R. Gorke, M. Hoefer, Z. Nikoloski, and D. Wagner, "On modularity clustering," IEEE Trans. Knowl. Data Eng., vol. 20, no. 2, pp. 172 -- 188, 2008. [5] M. Chen, K. Kuzmin, and B. K. Szymanski, "Community detection via maximization of modularity and its variants," IEEE Trans. Comput. Social Syst., vol. 1, no. 1, pp. 46 -- 65, 2014. [6] A. Clauset, M. E. J. Newman, and C. Moore, "Finding community struc- ture in very large networks," Phys. Rev. E, vol. 70, 2004. [7] M. E. J. Newman, "Modularity and community structure in networks," Proc. Natl. Acad. Sci., pp. 8577 -- 8582, 2005. [8] S. White and P. Smyth, "A spectral clustering approach to finding com- munities in graph," in Proc. SDM, 2005. [9] J. Reichardt and S. Bornholdt, "Statistical mechanics of community detec- tion," Phys. Rev. E, vol. 74, 2006. [10] J. Duch and A. Arenas, "Community detection in complex networks using extremal optimization," Phys. Rev. E, vol. 72, 2005. [11] S. Boccaletti, G. Bianconi, R. Criado, C. I. del Genio, J. G.-G. nes, M. Ro- mance, I. S. na Nadal, Z. Wang, and M. Zanin, "The structure and dy- namics of multilayer networks," Phys. Rep., vol. 544, no. 1, pp. 1 -- 122, 2014. [12] M. E. Dickison, M. Magnani, and L. Rossi, Multilayer social networks. Cambridge University Press, 2016. [13] M. Kivela, A. Arenas, M. Barthelemy, J. P. Gleeson, Y. Moreno, and M. A. Porter, "Multilayer networks," J. Complex Netw., vol. 2, no. 3, pp. 203 -- 271, 2014. [14] L. G. A. Alves, G. Mangioni, F. A. Rodrigues, P. Panzarasa, and Y. Moreno, "Unfolding the complexity of the global value chain: Strength and entropy in the single-layer, multiplex, and multi-layer international trade networks," Entropy, vol. 20, no. 12, 2018. [15] P. J. Mucha, T. Richardson, K. Macon, M. A. Porter, and J.-P. Onnela, "Community structure in time-dependent, multiscale, and multiplex net- works," Science, vol. 328, no. 5980, pp. 876 -- 878, 2010. [16] M. Coscia, F. Giannotti, and D. Pedreschi, "A classification for community discovery methods in complex networks," Stat. Anal. Data Min., vol. 4, no. 5, pp. 512 -- 546, 2011. [17] Z. Kuncheva and G. Montana, "Community detection in multiplex networks using locally adaptive random walks," in Proc. IEEE/ACM ASONAM, 2015, pp. 1308 -- 1315. [18] H. Zhang, C. Wang, J. Lai, and P. S. Yu, "Modularity in Complex Multi- layer Networks with Multiple Aspects: A Static Perspective," CoRR, vol. abs/1605.06190, 2016. [19] A. Tagarelli, A. Amelio, and F. Gullo, "Ensemble-based community detec- tion in multilayer networks," Data Min. Knowl. Discov., vol. 31, no. 5, pp. 1506 -- 1543, 2017. [20] D. Mandaglio, A. Amelio, and A. Tagarelli, "Consensus Community De- tection in Multilayer Networks Using Parameter-Free Graph Pruning," in Proc. PAKDD, 2018, pp. 193 -- 205. [21] S. Torreggiani, G. Mangioni, M. J. Puma, and G. Fagiolo, "Identifying the community structure of the food-trade international multi-network," Environ. Res. Lett., vol. 13, no. 5, p. 054026, 2018. [22] G. Mangioni, G. Jurman, and M. De Domenico, "Multilayer flows in molec- ular networks identify biological modules in the human proteome," IEEE Trans. Netw. Sci. Eng., 2018. [23] L. G. Alves, G. Mangioni, I. Cingolani, F. A. Rodrigues, P. Panzarasa, and Y. Moreno, "The nested structural organization of the worldwide trade multi-layer network," Sci. Rep., vol. 9, no. 1, p. 2866, 2019. [24] S. Fortunato and M. Barthelemy, "Resolution limit in community detec- tion," Proc. Natl. Acad. Sci., vol. 104, no. 36, 2007. [25] S. Fortunato, "Community detection in graphs," Phys. Rep., vol. 486, no. 3, pp. 75 -- 174, 2010. [26] L. Tang and H. Liu, Community Detection and Mining in Social Media, ser. Synthesis Lectures on Data Mining and Knowledge Discovery. Morgan & Claypool Publishers, 2010. [27] S. Fortunato and D. Hric, "Community detection in networks: A user guide," Phys. Rep., vol. 659, pp. 1 -- 44, 2016. [28] E. A. Leicht and M. E. J. Newman, "Community structure in directed networks," Phys. Rev. Lett., vol. 100, p. 118703, Mar 2008. [29] A. Arenas, J. Duch, A. Fern´andez, and S. G´omez, "Size reduction of com- plex networks preserving modularity," New J. Phys., vol. 9, no. 6, p. 176, 2007. [30] M. E. J. Newman, "Analysis of weighted networks," Phys. Rev. E, vol. 70, p. 056131, Nov 2004. [31] J. Xiang and K. Hu, "Limitation of multi-resolution methods in community detection," Physica A Stat. Mech. Appl., vol. 391, no. 20, pp. 4995 -- 5003, 2012. [32] J. Zhang, K. Zhang, X. ke Xu, C. K. Tse, and M. Small, "Seeding the kernels in graphs: toward multi-resolution community analysis," New J. Phys., vol. 11, no. 11, p. 113003, 2009. [33] A. Arenas, A. Fern´andez, and S. G´omez, "Analysis of the structure of complex networks at different resolution levels," New J. Phys., vol. 10, no. 5, p. 053039, 2008. [34] J. Xiang, Y.-N. Tang, Y.-Y. Gao, Y. Zhang, K. Deng, X.-K. Xu, and K. Hu, "Multi-resolution community detection based on generalized self- loop rescaling strategy," Physica A Stat. Mech. Appl., vol. 432, pp. 127 -- 139, 2015. [35] S. G´omez, P. Jensen, and A. Arenas, "Analysis of community structure in networks of correlated data," Phys. Rev. E, vol. 80, p. 016114, 2009. [36] V. A. Traag and J. Bruggeman, "Community detection in networks with positive and negative links," Phys. Rev. E, vol. 80, p. 036115, Sep 2009. [37] M. J. Barber, "Modularity and community detection in bipartite networks," Phys. Rev. E, vol. 76, p. 066102, 2007. [38] Y. Xu, L. Chen, and S. Zou, "Community detection from bipartite net- works," in Proc. IEEE WISA, 2013, pp. 249 -- 254. [39] R. Guimer`a, M. Sales-Pardo, and L. A. N. Amaral, "Module identification in bipartite and directed networks," Phys. Rev. E, vol. 76, p. 036102, 2007. [40] V. Nicosia, G. Mangioni, V. Carchiolo, and M. Malgeri, "Extending the definition of modularity to directed graphs with overlapping communities," J. Stat. Mech., vol. 2009, no. 03, p. P03024, 2009. [41] M. Berlingerio, M. Coscia, and F. Giannotti, "Finding and character- izing communities in multidimensional networks," in Proc. IEEE/ACM ASONAM, 2011, pp. 490 -- 494. [42] J. Kim and J. Lee, "Community detection in multi-layer graphs: A survey," SIGMOD Record, vol. 44, no. 3, pp. 37 -- 48, 2015. [43] L. Rossi and M. Magnani, "Towards effective visual analytics on multiplex and multilayer networks," Chaos, Solitons & Fractals, vol. 72, pp. 68 -- 76, 2015. [44] M. De Domenico, V. Nicosia, A. Arenas, and V. Latora, "Structural re- ducibility of multilayer networks," Nat. Commun., vol. 6, p. 6864, 2015. [45] M. Cha, A. Mislove, and K. P. Gummadi, "A Measurement-driven Analysis of Information Propagation in the Flickr Social Network," in Proc. WWW, 2009, pp. 721 -- 730. [46] G. Silvestri, J. Yang, A. Bozzon, and A. Tagarelli, "Linking accounts across social networks: the case of stackoverflow, github and twitter," in Proc. Work. on Knowl. Discov. on the Web, 2015, pp. 41 -- 52. [47] E. Omodei, M. De Domenico, and A. Arenas, "Characterizing interactions in online social networks during exceptional events," Frontiers in Physics, vol. 3, p. 59, 2015. [48] L. Tang, X. Wang, and H. Liu, "Uncovering groups via heterogeneous in- teraction analysis," in Proc. IEEE ICDM, 2009, pp. 503 -- 512. [49] N. Stanley, S. Shai, D. Taylor, and P. J. Mucha, "Clustering network layers with the strata multilayer stochastic block model," IEEE Trans. Netw. Sci. Eng., vol. 3, no. 2, pp. 95 -- 105, April 2016. [50] H. T. Ali, S. Liu, Y. Yilmaz, R. Couillet, I. Rajapakse, and A. O. Hero, "Latent heterogeneous multilayer community detection," in Proc. ICASSP, 2019. Appendix A Analytical derivation of lower and upper bounds Proof of Proposition 1 (Lower bound of Q). Let us assume that each of the (cid:96) layer graphs in GL has the form of a bipartite graph Ki(a, b), with i = 1, . . . , (cid:96), and sets a and b induce a partitioning of the set of nodes in two communities denoted as C1 and C2, respectively, so that C = {C1, C2} with C1= C2= n 2 , and no internal links are drawn between nodes of the same community (because of the bipartite assumption). To begin with, consider the reduction of Q to its simplest form, i.e., γ(L, C) fixed to 1 for any L, C and β = 0. Therefore, the contribution of community C1 to Q is: Since dL(C1) = n2 4 and d(VL) = n2 2 , Q(C1) is calculated as: (cid:19)2 . (cid:18) dL(C1) Q(C1) = −(cid:88) (cid:33)2 (cid:32) n2 Q(C1) = −(cid:88) 4 (2(cid:96)) = n2(cid:96) d(VL) L∈L n2(cid:96) 4 2 L∈L = − 1 4(cid:96) . The same above holds for C2. Therefore, the minimum value of Q when γ(L, C) = 1 and β = 0 is as follows: Q(C) = − 1 4(cid:96) 2 = − 1 2(cid:96) . (14) Let us now consider Q with its redundancy-based resolution factor while keeping β = 0. Since the internal degree of community C1 is 0, there are no redundant pairs for any community and layer, and hence γ(L, C) = 2. Conse- quently, the contribution of C1 to Q is: (cid:88) (cid:18) dL(C1) (cid:19)2 L∈L d(VL) (cid:18) 1 (cid:19)2 (cid:88) L∈L 2(cid:96) = −2 = − 1 2(cid:96) . Q(C1) = −2 The same above holds for C2. Therefore, the lower bound of Q when γ(L, C) is variable and β = 0 is as follows: Q(C) = − 1 2(cid:96) 2 = − 1 (cid:96) . (15) In the general form of Q with both resolution and inter-layer coupling factors (i.e., varying γ and β = 1), the contribution of C1 to Q is: −2 (cid:88) L∈L (cid:18) dL(C1) (cid:19)2 d(VL) (cid:88) + L(cid:48)∈P(L)  . IC(C1, L, L(cid:48)) d(VL) Q(C1) = In the above formula, let us indicate the terms X(C1) =(cid:80) and Y (C1) =(cid:80) . If we denote with p =(cid:80) (cid:33)2 total number of valid layer-pairings, then d(VL) = n2(cid:96) rewritten as follows: (cid:32) n2 L∈L,L(cid:48)∈P(L) IC(C1,L,L(cid:48)) d(VL) L∈L −2( dL(C1) d(VL) )2, L∈LP(L) the 2 + np, and X(C1) can be (cid:88) X(C1) = −2 4 L∈L n2(cid:96) 2 + np = − 1 2 n2(cid:96) (n(cid:96) + 2p)2 . For the reduction of the term Y (C1), we consider the two cases of symmetric inter-layer coupling and asymmetric inter-layer coupling. In the first case, the n . Accordingly, 1 1 ∩C(j) C(i) Vi∩Vj = 1 minimum value for ICs(C1, Li, Lj) is equal to Y (C1) is reduced as follows: 2p = n2(n(cid:96) + 2p) n2(cid:96) 2 + np 1 1 ∩C(j) C(i) Vi∩Vj × Vi 1 = 1 C(i) n × n n 2 = 2 n . Accord- Y (C1) = (cid:88) (cid:88) L∈L L(cid:48)∈P(L) (cid:88) (cid:88) 1 n 2 n In the second case, ICa(C1, Li, Lj) = ingly, Y (C1) is reduced as follows: Y (C1) = L∈L L(cid:48)∈P(L) n2(cid:96) 2 + np = 4p n2(n(cid:96) + 2p) . The above expressions for X and Y hold for C2. Therefore, the lower bound of Q in its general form is as follows: Q(C) =2(X(C1) + Y (C1)) = = − n2(cid:96) (n(cid:96) + 2p)2 + 4(1 + η)p n2(n(cid:96) + 2p) , (16) with η = 0 for ICs and η = 1 for ICa. It should be noted that Eq. 15 is a special case of Eq. 16 with β = 0 and d(VL) discarding the contribution given by the inter-layer edges (i.e., d(VL) = n2(cid:96) 2 ). Proof of Proposition 2 (Upper bound of Q). Let us assume that each of the (cid:96) layer graphs in GL has community structure C = {C1, C2} such that C1= C2= n edges. Moreover, there are no external edges connecting the communities, therefore dL(C) = dint L (C). Note that by uniformly distributing the n nodes into the two commu- nities, it can easily be shown that the maximum of Q is higher. 2 and each community is a clique with 2 −1) 2 ( n 2 n Analogously to the analysis of the minimum value of Q, let us first consider the setting γ(L, C) = 1, for any L, C, and β = 0. Therefore, the contribution of community C1 to Q is: (cid:18) dint (cid:19)2 . Q(C1) = dint L (C1) d(VL) − L (C1) d(VL) (cid:88) L∈L Because dint rewritten as: L (C1) = n 2 ( n 2 − 1)2(cid:96), the above expression is 2 ( n 2 − 1) and dL(V) = n (cid:18) n (cid:88) 2 − 1) 2 ( n 2 − 1)2(cid:96) 2 ( n − n n n L∈L 2 − 1) 2 ( n 2 − 1)2(cid:96) 2 ( n (cid:19)2 = 1 2 − 1 4(cid:96) . Q(C1) = The same above holds for C2. Therefore, the maximum of Q when γ(L, C) = 1 and β = 0 is as follows:1 (cid:19) (cid:18) 1 2 Q(C) = 2 − 1 4(cid:96) = 1 − 1 2(cid:96) = 2(cid:96) − 1 2(cid:96) . (17) Consider now the setting with redundancy-based γ(L, C) and β = 0. The contribution of C1 to Q is calculated as: Q(C1) = n 2 − 1) 2 ( n 2 − 1)2(cid:96) 2 ( n n − γ(L, C1) 2 − 1) 2 ( n 2 − 1)2(cid:96) 2 ( n n (cid:18) n (cid:19)2 . n 2 −1) Since nrp(L, C1) = , it follows that γ(L, C1) is equal to 2(1 + log2(1 + ))−1 for each layer and community. Note that the above constant quan- 2 ( n tity, hereinafter denoted as γ, tends to be (cid:28) 1, and it is smaller for higher 2 number of nodes n. The contribution of C1 to Q is rewritten as: The same above holds for C2. Therefore, the maximum of Q with redundancy- based γ(L, C) and β = 0 is as follows: Q(C) = 2 − γ 1 4(cid:96) = 1 − γ 1 2(cid:96) = 2(cid:96) − γ 2(cid:96) . (18) Q(C1) = 1 2 − γ 1 4(cid:96) . (cid:21) (cid:20) 1 2 (cid:88) L∈L 2 −1) n 2 ( n 2 Note that the above quantity is as much closer to 1 as n and (cid:96) are higher. In the general setting of Q with redundancy-based γ(L, C) and β = 1, the contribution of C1 to Q is: Q(C1) = (cid:34) (cid:88) (cid:88) L∈L + − γ(L, C) dint L (C1) d(VL) IC(C1, L, L(cid:48))  . (cid:18) dint (cid:19)2 L (C1) d(VL) + In the above formula, let us indicate the terms X(C1) =(cid:80) L(cid:48)∈P(L) d(VL) d(VL) )2], and Y (C1) =(cid:80) L (C1) L∈L(cid:80) IC(C1,L,L(cid:48)) L(cid:48)∈P(L) d(VL) γ(L, C)( dint L∈L[ dint L (C1) d(VL) − L (C1) = . Because dint 1If C1 and C2 would have n − 1 and 1 nodes, respectively, the resulting maximum value of Q will be (cid:96)−1 (cid:96) , hence lower than what we obtain in Eq. 17. (cid:88) (cid:88) Y (C1)= L∈L L(cid:48)∈P(L) n( n In the second case, ICa(C1, Li, Lj) = Therefore: (cid:88) (cid:88) L∈L L(cid:48)∈P(L) Y (C1)= follows: 1 n p = n2( n 2 − 1)(cid:96) + n2p 2 − 1)(cid:96) + np C(i) 1 ∩C(j) 1 Vi∩Vj × Vi 1 = 1 C(i) . n × n n 2 = 2 n . 2 n 2 − 1)2(cid:96) + np n 2 ( n = 2p n2( n 2 − 1)(cid:96) + n2p . 2 −1) n 2 ( n 2 ))−1 n 2 ( n 2 ( n for each layer and community, we obtain: 2 − 1)2(cid:96) + np, and γ(L, C1) = 2(1 + log2(1+ 2 − 1), dL(V) = n (cid:19)2 (cid:88) (cid:18) 2 − 1) n X(C1)= = = 1 2 L∈L (cid:18) 1 n 2 ( n 2 − 1)2(cid:96) + np 2 ( n 2 − 1)(cid:96) ( n − γ(cid:96) 2 − 1)(cid:96) + p (cid:88) (cid:88) ( n 2 Y (C1) = L∈L L(cid:48)∈P(L) − γ n 2 ( n 2 − 1)2(cid:96) + np 2 − 1) (cid:19)2 n 2 ( n 2 − 1) ( n 2 − 1)(cid:96) + p ( n IC(C1, L, L(cid:48)) 2 − 1)2(cid:96) + np 2 ( n n , . For the reduction of the term Y (C1), we again consider the two cases of symmetric inter-layer coupling and asymmetric inter-layer coupling. In the first case, ICs(C1, Li, Lj) = C(i) 1 ∩C(j) 1 Vi∩Vj = 1 n . Therefore: The same above holds for C2. Therefore, the maximum value of Q is as (cid:34) Q(C) =2(X(C1) + Y (C1)) = − γ(cid:96) 2 − 1)(cid:96) ( n 2 − 1)(cid:96) + p ( n =2 1 2 (cid:18) 1 2 2 − 1) ( n 2 − 1)(cid:96) + p ( n (cid:19)2 + (19) (cid:21) (1 + η)p 2 − 1)(cid:96) + n2p with η = 0 for ICs and η = 1 for ICa. n2( n + It is worth noting that Eq. 18 is a special case of Eq. 19 with β = 0 and d(VL) discarding the contribution given by the inter-layer edges. B Evaluation with ordered layers Figure 13 provides further details on correlation analysis using descendent layer ordering. (a) (c) (b) (d) Figure 13: Pearson correlation coefficient between average path length (APL), clustering coefficient (CC), node coverage (NC), edge coverage (EC), redun- dancy (RED), and the multilayer modularity Q with γ(L, C) and IC Adj ia , IC Adj oa , IC Suc oa , and descendent layer ordering, computed on the solution found by (a) GL, (b) LART, (c) PMM, and (d) M-EMCD∗ on the EU-Air network. Each statistics is computed at community-level ia , IC Suc C Efficiency results Figures 14 -- 15 show the computation time of Q for the different combinations of γ and IC factors. APL CC NC EC RED 00.250.50.751CorrelationICiaAdj ICoaAdj ICiaSuc ICoaSuc APL CC NC EC RED 00.250.50.751CorrelationICiaAdj ICoaAdj ICiaSuc ICoaSuc APL CC NC EC RED 00.250.50.751CorrelationICiaAdj ICoaAdj ICiaSuc ICoaSuc APL CC NC EC RED 00.250.50.751CorrelationICiaAdj ICoaAdj ICiaSuc ICoaSuc (a) IC Adj ia (b) IC Adj oa (c) IC Suc ia (d) IC Suc oa Figure 14: Computation time (in seconds) of the multilayer modularity Q, with γ = 1, measured on the solution found by GL on the multiplex LFR network (a) IC Adj ia (b) IC Adj oa (c) IC Suc ia (d) IC Suc oa Figure 15: Computation time (in seconds) of the multilayer modularity Q, with redundancy-based γ(L, C), measured on the solution found by GL on the mul- tiplex LFR network
1904.07569
1
1904
2019-04-16T10:00:55
Investigating the Effect of Attributes on User Trust in Social Media
[ "cs.SI", "cs.IR" ]
One main challenge in social media is to identify trustworthy information. If we cannot recognize information as trustworthy, that information may become useless or be lost. Opposite, we could consume wrong or fake information with major consequences. How does a user handle the information provided before consuming it? Are the comments on a post, the author or votes essential for taking such a decision? Are these attributes considered together and which attribute is more important? To answer these questions, we developed a trust model to support knowledge sharing of user content in social media. This trust model is based on the dimensions of stability, quality, and credibility. Each dimension contains metrics (user role, user IQ, votes, etc.) that are important to the user based on data analysis. We present in this paper, an evaluation of the proposed trust model using conjoint analysis (CA) as an evaluation method. The results obtained from 348 responses, validate the trust model. A trust degree translator interprets the content as very trusted, trusted, untrusted, and very untrusted based on the calculated value of trust. Furthermore, the results show different importance for each dimension: stability 24%, credibility 35% and quality 41%.
cs.SI
cs
Investigating the Effect of Attributes on User Trust in Social Media Jamal Al Qundus Adrian Paschke Computer Science, Freie Universitat Berlin, Email: [email protected] Data Analytics Center, Fraunhofer FOKUS, Berlin, Email: [email protected] 9 1 0 2 r p A 6 1 ] I S . s c [ 1 v 9 6 5 7 0 . 4 0 9 1 : v i X r a Abstract -- One main challenge in social media is to identify trustworthy information. If we cannot recognize information as trustworthy, that information may become useless or be lost. Opposite, we could consume wrong or fake information - with major consequences. How does a user handle the information provided before consuming it? Are the comments on a post, the author or votes essential for taking such a decision? Are these attributes considered together and which attribute is more important? To answer these questions, we developed a trust model to support knowledge sharing of user content in social media. This trust model is based on the dimensions of stability, quality, and credibility. Each dimension contains metrics (user role, user IQ, votes, etc.) that are important to the user based on data analysis. We present in this paper, an evaluation of the proposed trust model using conjoint analysis (CA) as an evaluation method. The results obtained from 348 responses, validate the trust model. A trust degree translator interprets the content as very trusted, trusted, untrusted, and very untrusted based on the calculated value of trust. Furthermore, the results show a different importance for each dimension: stability 24%, credibility 35% and quality 41%. Index Terms -- Social Media, Trust, Conjoint Analysis I. INTRODUCTION Users consume information when they have trust in it. One main challenge in social media is how to identify trustworthy information. For instance, relevant information such as storm warning or medical instruction could not be considered by users, if it is not recognized as trustworthy. Usually, users look at properties (e.g. author, reviews, etc.) to take decision to trust the information. However, many questions arise when it comes to which properties are relevant and how important they are for the user to consume this information. Social media (SM) have many users, which makes it well suitable for examining user activities on the information pro- vided. Therefore, we considered the SM Genius (www.genius. com) as a case study to measure user's willingness to trust the information provided on this platform. Interactively, users on Genius create annotations that serve as placeholders for the interpretations of texts, especially lyrics and literature. Annotations provide editing functions such as voting, shar- ing, adding comments, etc. Participation in this platform is described by certain activities. These activities are linked to certain user authorizations (e.g. roles: whitehat, artist, editor, etc.). Based on these authorizations, a user can perform certain activities and earn Intelligence Quotient (IQ)1, which indicates the experience required for authorization and acceptance of content [1]. The focus of this article is to determine the properties that are important for user trust in the user-generated content environment (i.e. any content generated by the user on Genius that is an annotation, a comment, or a modification). Existing research [2] -- [5] tackles this problem of trust by verifying the history of the generated content, reputation and algorithms for detecting vandalism. In the contract, we esti- mate user preferences on content properties that are relevant in making decision to consume (trust) the information. This gives us an idea of how we can present information in social media using a template that helps identify trusted information. To obtain such a template, the user's willingness to trust should be measured by (1) simulating a number of templates that include different properties and (2) estimating the user's choices. Measuring user's willingness leads to the construction of a trust model that quantifies the value of trust and at the same time embodies in its structure the construction of the required template. This can be evaluated with the use of the conjoint analysis (CA) [6] method, which simulates the decision-making process of consumers when choosing products in real life. To build our model, we analyzed first, the data collected from Genius based on user activities (e.g. annotation, voting, comments). Then, we select the metrics used in Genius that correspond to user activities (for instance, "annotation" corre- sponds to "annotation IQ1", , "vote" to "edit IQ1"). Finally, we looked for a correlation between the metrics defined in the dimensions of the existing trust models in the literature and those defined in Genius. With this literature review, we classified the metrics into three dimensions namely: stability, credibility and quality. These dimensions are then integrated into our trust model. This trust mode can be used as well for other social media having the same content properties. Our main emphasis in this paper is to provide a reliable assessment of the selected dimensions and their acceptance by web users in general. This can be conducted by estimating the user choices using a Discrete Choice Conjoint analysis (DCC), which is a form of CA evaluation method. 1Intelligence Quotient is a counter of points awarded for activities on Genius. The paper is structured as follows: Section II provides a brief overview of relevant works. Section III describes the dimensions of the trust model and an illustrative example to compute trust. Section IV presents the preparation of the survey. Section V reports and discusses the findings. Section VI contains the summary and concludes with proposals for further investigation. II. RELATED WORK Dondio et al. propose a Wikipedia Trust Calculator (WTC) consisting of a data retrieval module that contains the required data of an article. A factor-calculator module calculates the confidence factors. A trust evaluator module transfers the numerical confidence value in a natural language declaration using constraints provided by a logic conditions module [7]. This approach refers exclusively to Wikipedia and cannot be transferred into other domains such as social media. In addition, the aim here is to detect vandalism and not trust in our definition. The trust model of Abdul-Rahman and Hailes is based on sociological characteristics. These are trusted beliefs between agents based on experience (of trust) and reputation (came from a recommended agent) combined to build a trusted opinion to make a decision about interacting with the information provided [8]. This approach combines reputation and agents together to build trust. These metrics are not available in our domain. These two works are closely linked to our work. Our approach is comparable to that of Dondio et al., and in particular their work has inspired the calculation of the sta- bility dimension. The authors build the stability based on the change (defined as edit) in the text length of an article. While the stability dimension in our work is built on any type of editing (vote, suggestion, creation, etc.) to an annotation. In addition, we have adapted the trust degree translator from Abdul-Rahman and Hailes [8]. Based on data base analysis, we manually defined its constraints, that are used for interpretation of the numeric trust value into a human-readable language. Cho et al. investigated trust in different contexts and dis- cussed trust from various aspects. The authors employed a survey to investigate social trust from interactions/networks, and captured of quality of service (QoS) and quality of information (QoI) depending on a relation between two entities (trustor and trustee) [9]. However, this is an examination of trust and reputation systems in online services [10]. These works and others must be placed in a restricted domain to find a relationship between the communicating entities. However, this is not always possible in an unlimited domain like social media. Different from the prior works, this survey brings together the aspects of trust from a specific, but open domain and let entities evaluate them from outside of this domain. Additionally, we suggest an advanced equation for measuring trust. III. TRUST MODEL CONSTRUCTION We conducted investigation on the social media Genius as a case study to build our trust model, as follows: First, we analyzed the data collected from Genius based on user activ- ities (e.g. annotation, voting, comments). Then, we select the metrics used in Genius that correspond to user activities (for instance, "annotation" corresponds to "annotation IQ1", "vote" to "edit IQ1"). Furthermore, other metrics are considered such as the metric "author role" (e.g. editor, or whitehat) which is not considered as an activity but as important metric in Genius (for more detail see Genius technical report [11]). Finally, we looked for a correlation between the metrics defined in the dimensions of the existing trust models in the literature [7], [12] -- [15] and those defined in Genius. For instance, the dimension credibility comprised the metrics set: user role, user IQ, attribution and annotation IQ. With this literature review, we classified the metrics into three dimensions namely: stability, credibility and quality. These dimensions are then integrated into our trust model. The trust model classifies annotations into four classes [8] called trust degrees illustrated in Table I. These classes were obtained by the database analysis based on the Empirical Cumulative Distribution Function (ECDF) [16]. Next, we present the formulas used to compute trust. TABLE I TRUST DEGREE TRANSLATOR Trust Degree vt t u vu Percentage 25% 31.25% 6.25% 37.5% Edits number >5 2 to 5 0 to 2 <0 Edits IQ >35 5 to 35 0 to 5 <0 User IQ >1000 0 to 1000 -100 to 0 <-100 Tab.I illustrates the trust degree translator for the interpretation of the individual statement trust classes. vt = very trusted, t = trusted, u = untrusted, vu = very untrusted. Percentage results from the ECDF applied data analysis observed on Genius, and illustrates the distribution of statements' (annotations) trust classes in the data set. Trust: is calculated based on the dimensions stability, cred- ibility and quality. The trust value obtained is then interpreted by the trust degree translator to identify the annotation class: very trusted, trusted, untrusted and very untrusted. trust = α × stability + β × credibility + γ × quality α, β and γ are the importance factors of each dimension. (1) • Stability (S) is represented by the annotation edits' dis- tance (see Equation 3), which represents several content modifications in a time interval. For example, the interval could be between the initial time stamp of the annotation and the current time. E(t) (see Equation 2) specifies the number of edits at the time stamp t. {E(t) : t → ΦE : editsf unction, t : timestamp, Φ ∈ Z} (2) Here, Z is a set of all integers. {S = t=p(cid:88) E(t)t & p : timestamp, E : editsf unction} t=t0 (3) • Credibility (C) refers to correctness, authorship and the depth in meaning of information. We consider the type of user activity on an annotation as editsType. There are complex activities (e.g. annotation creation) that require agility from the user during execution. We should note that the ranks of these complex activities in Genius are higher than so-called simple activities (e.g. annotation voting). In addition, we applied a User Credibility Cor- rection Factor (UCCF), which is calculated based on the users role2, user IQ3 and attribution4 for modifying the credibility status. U CCF + editsT ypes C = (4) a.attribution × Where UCCF= foreach author a.rolePower. And a.rolePower = a.role × a.roleFactor × a.IQ. a: 2 • Quality (Q) is calculated exactly like C, except for the restriction to n-top active users 5, who are ordered based on their attribution. U CCF (cid:48) + editsT ypes(cid:48) Q = 2 (5) Before presenting an example that illustrates how the trust is calculated, we introduce the terms utility and importance. The utility or part-worth is a measure of how important an attribute level is for a trade-off decision by the user. Whereas the relative importance of an attribute is the delta percentage compared to all utilities. Each time a respondent makes a choice, an accumulator compiles the numbers. These numbers indicate how often a level has been selected. The algorithm used for calculating the utilities is logit model[17] combined with a Nelder-Mead Simplex algorithm [18]. The utility (U) of an attribute level (l) is calculated by the distance from its selected value (S) to the minimum (min) level selected value of the same attribute (k) as shown in the following Equation 6: Ual = Skl − Sklmin (6) The importance (I) of an attribute (k) is calculated by the difference between the maximum selected number (Sklmax) and the minimum selected number (Sklmin) of this attribute level, divided by the sum of such differences over all attributes A = {a1, a2, . . . , k, . . . , an} (see Equation 7). (cid:80)a=n Sklmax − Sklmin a=1 (Salmax − Salmin) Ik = × 100% (7) A. Illustrative Example In this section, we present an example that illustrates how we apply the results of CA in evaluating the dimensions and as a consequence of that, computing trust of an annotation. 2Genius members have roles that differ in the permissions assigned to them. The IQ numbers earned for an activity also depend on the role type. 3The overall earned IQ count of a user. 4Attribution is the percentage of edits made by a user. 5n is a number that the observer can freely select. A discrete choice conjoint analysis (DCC) provides a quan- tity6 of tasks. A task consists of a set of concepts, each concept represents a certain number of attribute levels. Users select a concept that they would trust in reality. Figure 1 illustrates a task used in our conjoint design. Each task concept contains the attributes Comments, Reader Rating and Author Rating and their randomly generated levels values. The attributes act in place of the trust dimensions. Table II provides an example of the collected numbers of user trade-offs. The columns Level, Selected and Offered are predefined. We only explain the calculations for one attribute Comments, since the calculations for the attributes Reader Rating and Author Rating are analog. Utility: Equation 6 is applied as follows: a = Comment, l = level, Salmax = maximum level selected value, Salmin = minimum level selected value, Ual = 0 l = 2 l = 0 Ual = 0 − 0 = 0 Ual = 2 − 0 = 2 l = 5 Ual = 5 − 0 = 5 Ual = 10 − 0 = 10 l = 10 (cid:80)A relative Importance: (see Equation 7) is applied as follows: a=1(Salmax−Salmin) = (61−2)+(72−5)+(80−1) = 205 k = Comments, Sklmax = 61, Sklmin = 2. Ik ∈ {α, β, γ}7= × 100% ≈ 29% 61 − 2 205 trust: (ω) can be now calculated based on the dimensions' Equations 3, 4, 5 and 1 as follows: Let the number of edits of an annotation be 50 from the creation time to the current time. From these edits are 10 complex edits (CE) (e.g. content modification) and 40 simple edits (SE) (e.g. voting). The edits IQ equals 30. The users' roles are (editor (25), whitehat (3) and staff (38)), the sum total of users' (authors') IQ equals 160 (10, 30 and 120, respectively) and their attributions ( 70% with 2 CE and 7 SE, 28% with 7 CE and 30 SE and 2% with 1 CE and 3 SE, respectively). The n = 2 for the n-top active user. Based on this input the stability, credibility and quality can be calculated, as follows: Stability = 50 Credibility = 7.285 + 7.5 where UCCF = foreach author a: a.attribution × a.rolePower And a.rolePower = a.role × a.roleFactor × a.IQ UCCF = 0.7 × (25 × 0.025 × 10) + 0.28 × (3 × 0.025 × = 7.392 30) + 0.02 × (38 × 0.025 × 120) = 7.285 = 30 × 10 40 = 6.151 EditsTypes = edit IQ × CE SE 5.005 + 7.297 Qualityn=2 = where UCFF' = U CF F −0.02×(38×0.025×120) = 5.005 EditsTypes' = editIQ × CE(cid:48) Trust = 0.29 × 50 + 0.33 × 7.392 + 0.39 × 6.151 = 19.338 SE(cid:48) = 30 × 9 = 7.297 = 7.5 37 2 2 6Number depends on the conjoint analysis design. 7β=0.33, γ=0.39 Fig. 1. 9 presents a task that illustrates one step in the conjoint analysis profile. This task is displayed to the respondents to make a trade-off on the provided concepts. A concept consists of attributes (Comments, Reader Rating and Author Rating) and randomly generated levels values combined to alternatives. Trust degree translator interprets the trust value ω ≥ 15 as very trusted, 15 > ω ≥ 13.5 as trusted, 13.5 > ω ≥ 12 as untrusted and ω < 12 as very untrusted. ATTRIBUTES AND LEVELS CALCULATION EXAMPLE TABLE II Attribute Level Selected Utility Offered rel.Importance Comment Reader Rating Author Rating 0 2 5 10 0 10 30 70 -100 0 1000 2000 2 33 44 61 5 24 39 72 1 7 52 80 0 2 5 10 0 10 30 70 0 100 1100 2100 5% 24% 31% 40% 4% 17% 28% 51% 5% 7% 37% 51% 29% 33% 39% Tab.II gives an example of calculating the attributes relative importance. Attribute = the property of a statement, Level = one possible value an attribute can take, Selected = the number of selection frequency of respondents, Utility = level's important to the respondents choice decision, Offered = display frequency to the respondents, relative Importance = measure of how preferred an attribute is to the respondents choice decision. IV. METHODOLOGY Our approach applies DCC as follows: Using e-mail, we announced a link to the online survey in Arabic, English and German. In the DCC we described the attributes (see Table III): (1) Comments as "a number that indicates improvement edits created by other readers", (2) Reader Rating as "a number of other readers' approval" and (3) Author Rating as "a number of voting that the author earned for his activities in the social network". We also stated that "The greater the number, the greater the satisfaction". Each number represents the sum of negative and positive assertions. There are comments that were rated negatively and other comments that were rated positively by readers. Negatives were marked with minus and positives with plus numbers. Subsequently, both numbers were summed up. This applies to all properties". 8www.questionpro.com 9www.questionpro.com levels Due to the amount of information in a full-profile design (43attributes makes 64 alternatives), a complied questionnaire would become too extensive. Therefore, we decided to use a 2. The conducted fractional factorial-design within the factor 1 DCC consists of 32 concepts and the respondents were also given four alternatives to choose from in each task. V. RESULTS AND DISCUSSION nta Johnson and Orme recommend a rule-of-thumb for the ≥ 500) [19]. minimum sample sizes for CBC modeling ( Where n: the respondents number, t: the tasks number, a: the number of alternatives per task and c: the highest level number over all attribute. Accordingly, our questionnaire response has a satisfactory number of participants 10. The questionnaire received responses that were distributed over 12 countries, which supports the results to be more significant and we experienced responses from a widely distributed audience. c The areas of emphasis of the individual statements met all our expectations and are in line with the proposed theoretical trust model. The selected properties included in the dimensions is important to the users by making a decision to trust the information provided. Table III presents the best profile (levels: +10, +70 and +2000) and the worst profile ( levels: 0, 0, - 100). These two results are interpreted as very trusted and the worst profile as very untrusted respectively by the trust degrees translator. As a reminder, the values of levels in the questionnaire and the numbers applied into the trust degree translator are obtained from the analysis of the database col- lected from Genius. This table provides information regarding the importance of the attributes and the utilities of the levels. The analysis of the respondents' choice decisions has been conducted by the authors of this paper. This analysis provides a summary from which we can conclude the following: I None of the attributes was excluded from the choice decision. All defined dimensions have significance in the proposed trust model. Importance of stability, credibility and quality are 24%, 35% and 41% respectively) (see Table III). If a dimension had turned out less significance, this would mean that it has no relevancy for the model and should not be considered. This result is an indicator that the model is accepted and confirmed by the evaluators. II None of the attributes has an extremely high value. None of the dimensions alone make up the model. That would mean that we can neglect all other dimensions and focus exclusively on one. In addition, it would indicate that other components or dimensions are essential for trust in this context and our model did not consider them. III The importance of the attributes is about equally dis- persed. This confirms our preliminary consideration when we weighted the dimensions nearly equal (see Equation 1). Nevertheless, it was not possible to determine a more precise weighting for the trust calculation until this evaluation. In which, the respondents printed out their importance weight distribution of each dimension. 10348 responses with a completion rate of 40.65% Applying this weighting into the equation we can improve the calculation with coefficients that are derived from the percentages of the individual domain rankings. IV There is a distinct subdivision of the utilities of an attribute into four parts. The resulted subdivision is in line with the classes of the trust degrees. The levels of an attribute exhibit clear differences on how often they have been selected (see Table III). We can reclassify the distribution of the levels utilities of individual attribute in the classes. This applies to all attributes. V The distinct subdivisions agree over all attributes re- spectively. This corresponds with the prior statement and represents an extension that the subdivision of the levels utilities on an attribute stage continues to move across all attributes levels and in the same order (see Table III). If we number the trust classes and the levels of each attribute consecutively, we realize that the first level of each attribute can be assigned to the first trust class (very untrusted) and the second attributes levels can be assigned to the second class (untrusted) and so forth. For instance, The utility (-0.90) of the first level (-100) of the attribute author rating, the utility (-0.82) of the first level (0) of the attribute reader rating and the utility (-0.67) of the first level (0) of the attribute comments, present together a concept that was the least rated once by the respondents. This concept is classified as very untrusted by our trust model. This is applied for the second, third and fourth levels of each attribute respectively. ATTRIBUTES IMPORTANCE AND LEVELS UTILITIES RESULTS TABLE III Author Rating (quality) 40.85% Level -100 0 +1000 +2000 Utility -0.90 -0.39 +0.44 +0.86 Reader Rating (credibility) 34.8% Utility -0.82 -0.18 +0.29 +0.71 Level 0 +5 +30 +70 Comments (stability) 24.35% Level 0 +2 +5 +10 Utility -0.67 -0.04 +0.24 +0.47 Table III gives the attributes importance, the levels and their utilities as the measure for the respondents' preferences. This refines the weights of the attributes acting in place of the trust model dimensions. VI. CONCLUSION AND FUTURE WORK This work carried out an evaluation of the trust model using a conjoint analysis to determine the respondents' choice. The information gained from the results confirm our trust model. In its structure is the required template included that helps identify trusted information according to user estimated preferences. This model consists of three dimensions: stability, credibility and quality which were adopted from the literature and the Genius platform. This model is intended to support the development of successful applications. The used logit model provides effective analysis and con- vincing results. Nevertheless, an analysis using the hierarchical bayes would allow us to take a fresh look at the selections of individuals. With hierarchical bayes we would be able to trace the history of respondent's decisions and possibly expose some more details about their behavior. After the respondents' conclusions about the developed model have been drawn, it is necessary to investigate the database from which the model was created. A clustering procedure should be used to identify which text content belong to which trust category and why. The content-related parameters are to be investigated. REFERENCES [1] J. A. Qundus, "Generating trust in collaborative annotation environ- ments," in Proceedings of the 12th International Symposium on Open Collaboration Companion. ACM, 2016, p. 3. [2] H. Li, J. Jiang, and M. Wu, "The effects of trust assurances on consumers initial online trust: A two-stage decision-making process perspective," International Journal of Information Management, vol. 34, no. 3, pp. 395 -- 405, 2014. [3] C. L. Miltgen and H. J. Smith, "Exploring information privacy regu- lation, risks, trust, and behavior," Information & Management, vol. 52, no. 6, pp. 741 -- 759, 2015. [4] H. Liu, E.-P. Lim, H. W. Lauw, M.-T. Le, A. Sun, J. Srivastava, and Y. Kim, "Predicting trusts among users of online communities: an epinions case study," in Proceedings of the 9th ACM Conference on Electronic Commerce. ACM, 2008, pp. 310 -- 319. [5] B. T. Adler, L. De Alfaro, S. M. Mola-Velasco, P. Rosso, and A. G. West, "Wikipedia vandalism detection: Combining natural language, metadata, and reputation features," in International Conference on Intelligent Text Processing and Computational Linguistics. Springer, 2011, pp. 277 -- 288. [6] R. D. Luce and J. W. Tukey, "Simultaneous conjoint measurement: A new type of fundamental measurement," Journal of mathematical psychology, vol. 1, no. 1, pp. 1 -- 27, 1964. [7] P. Dondio, S. Barrett, S. Weber, and J. M. Seigneur, "Extracting trust from domain analysis: A case study on the wikipedia project," in International Conference on Autonomic and Trusted Computing. Springer, 2006, pp. 362 -- 373. [8] A. Abdul-Rahman and S. Hailes, "Supporting trust in virtual communi- ties," in System Sciences, 2000. Proceedings of the 33rd Annual Hawaii International Conference on. IEEE, 2000, pp. 9 -- pp. [9] J.-H. Cho, K. Chan, and S. Adali, "A survey on trust modeling," ACM Computing Surveys (CSUR), vol. 48, no. 2, p. 28, 2015. [10] A. Jøsang, R. Ismail, and C. Boyd, "A survey of trust and reputation systems for online service provision," Decision support systems, vol. 43, no. 2, pp. 618 -- 644, 2007. [11] J. Al Qundus, "Technical analysis of the social media platform genius," Freie Universitat Berlin, Tech. Rep., 2018. [Online]. Available: http: //edocs.fu-berlin.de/docs/receive/FUDOCS document 000000029280 [12] M. J. Metzger, A. J. Flanagin, K. Eyal, D. R. Lemus, and R. M. McCann, "Credibility for the 21st century: Integrating perspectives on source, message, and media credibility in the contemporary media environment," Annals of the International Communication Association, vol. 27, no. 1, pp. 293 -- 335, 2003. [13] I. Pranata and W. Susilo, "Are the most popular users always trustwor- thy? the case of yelp," Electronic Commerce Research and Applications, vol. 20, pp. 30 -- 41, 2016. [14] M. Warncke-Wang, D. Cosley, and J. Riedl, "Tell me more: an actionable quality model for wikipedia," in Proceedings of the 9th International Symposium on Open Collaboration. ACM, 2013, p. 8. [15] B. Fogg, J. Marshall, O. Laraki, A. Osipovich, C. Varma, N. Fang, J. Paul, A. Rangnekar, J. Shon, P. Swani et al., "What makes web sites credible?: a report on a large quantitative study," in Proceedings of the SIGCHI conference on Human factors in computing systems. ACM, 2001, pp. 61 -- 68. [16] R. Castro, "The empirical distribution function and the histogram," Lecture Notes, 2WS17-Advanced Statistics. Department of Mathematics, Eindhoven University of Technology, 2015. [17] J. J. Louviere and G. Woodworth, "Design and analysis of simulated consumer choice or allocation experiments: an approach based on aggregate data," Journal of marketing research, pp. 350 -- 367, 1983. [18] J. A. Nelder and R. Mead, "A simplex method for function minimiza- tion," The computer journal, vol. 7, no. 4, pp. 308 -- 313, 1965. [19] R. M. Johnson and B. K. Orme, "How many questions should you ask in choice-based conjoint studies," in Art Forum, Beaver Creek, 1996.
1308.1857
1
1308
2013-08-08T14:06:51
PANAS-t: A Pychometric Scale for Measuring Sentiments on Twitter
[ "cs.SI", "physics.soc-ph" ]
Online social networks have become a major communication platform, where people share their thoughts and opinions about any topic real-time. The short text updates people post in these network contain emotions and moods, which when measured collectively can unveil the public mood at population level and have exciting implications for businesses, governments, and societies. Therefore, there is an urgent need for developing solid methods for accurately measuring moods from large-scale social media data. In this paper, we propose PANAS-t, which measures sentiments from short text updates in Twitter based on a well-established psychometric scale, PANAS (Positive and Negative Affect Schedule). We test the efficacy of PANAS-t over 10 real notable events drawn from 1.8 billion tweets and demonstrate that it can efficiently capture the expected sentiments of a wide variety of issues spanning tragedies, technology releases, political debates, and healthcare.
cs.SI
cs
SYSTEMS, MAN, AND CYBERNETICS, PART C: APPLICATIONS AND REVIEWS, VOL. XX, NO. XX, JUNE 2013 1 PANAS-t: A Pychometric Scale for Measuring Sentiments on Twitter Fabr´ıcio Benevenuto(cid:63)† Meeyoung Cha‡ Pollyanna Gonc¸ alves(cid:63) †Computer Science Department, Federal University of Ouro Preto, Brazil (cid:63)Computer Science Department, Federal University of Minas Gerais, Brazil ‡Graduate School of Culture Technology, KAIST, Korea 3 1 0 2 g u A 8 ] I S . s c [ 1 v 7 5 8 1 . 8 0 3 1 : v i X r a Abstract—Online social networks have become a major com- munication platform, where people share their thoughts and opinions about any topic real-time. The short text updates people post in these network contain emotions and moods, which when measured collectively can unveil the public mood at population level and have exciting implications for businesses, governments, and societies. Therefore, there is an urgent need for developing solid methods for accurately measuring moods from large-scale social media data. In this paper, we propose PANAS-t, which measures sentiments from short text updates in Twitter based on a well-established psychometric scale, PANAS (Positive and Negative Affect Schedule). We test the efficacy of PANAS-t over 10 real notable events drawn from 1.8 billion tweets and demon- strate that it can efficiently capture the expected sentiments of a wide variety of issues spanning tragedies, technology releases, political debates, and healthcare. Index Terms—Twitter, sentiment analysis, public emotion, public mood, psychometric scales, PANAS. I . IN TRODUC T ION Online social networks (OSNs) like Facebook and Twitter have become an important communication platform, where people share their thoughts and opinions about any topic in a collaborative manner in real-time. As of 2012, Facebook has over one billion active users, which is one-seventh of the world population, and Twitter similarly has over 400 million registered users each producing hundreds of millions of status updates every day [36]. Given the scale and the richness of these networks, the potential for mining the data within OSNs and utilizing observations from such data is tremendous, and OSN data have been a gold mine for scholars in fields like linguistics, sociology, and psychology who are looking for real-time language data to analyze [25]. The massive-scale detailed human lifelog data found in OSNs have important implications for businesses, govern- ments, and societies. The following areas of research demon- strate directly how useful observations from mining OSN data could be. First, social media data can be used to find resonance of important real-time debates and breaking news. As more people are seamlessly connected to the Web and OSN sites by mobile devices, people participate in delivering and propagating prominent and urgent information like political uprising [21], [9], natural disasters [32], and the upheaval of epidemics [15]. Second, social media data can be used to not only understand the current trends but also predict future trends such as movie sales [2], political elections [33], [12], [28], as well as stock market [7]. The key features of OSN data that allow for the above implications is at their immediacy and immensity, for which the development of new methods on large-scale and real-time collection and analysis of OSN data are crucial. One such important development is at inferring sentiments in OSNs. A recent work has showed that real-time moods of people can be gauged on a global level, instead of relying on questionnaires and other laborious and time-consuming methods of data collection [14]. Measuring sentiments from unstructured OSN data can not only broaden our understanding of the human nature, but also comprehend how, when, and why individuals’ feelings fluctuate according to various social and economic events. While sentiment analysis in OSNs is getting great attention, existing work on measuring sentiments from OSN data has focused on extracting opinions (not feelings) for marketing purposes [30] and on finding correlation of moods with some other factor such as happiness [13] and stock price [7]. Most research on inferring moods from social media texts have directly employed existing natural language processing tools like LIWC (Linguistic Inquiry and Word Count) [31], PANAS (Positive and Negative Affect Schedule) [35], [34], ANEW (Affective Norms for English Words) [23], and Profile of Mood States (POMS) [7] that have been developed to suit more traditional style writing, such as formal articles that uses proper language (but not for unstructured and less- formal OSN data). However, relatively little attention has been paid developing solid methods for adjusting existing natural language processing tools for specific types of OSN data. In this paper, we use well-established psychometric scales, PANAS, to measure sentiments from short text updates in Twitter and propose PANAS-t, which is an eleven-sentiment psychometric scale adapted to the context of Twitter. PANAS- t contains positive and negative mood states and is suitable to measure sentiments about any sort of event in Twitter. To establish PANAS-t, we used empirical data from a unique dataset containing 1.8 billion tweets. We used such data to compute normalization scores for each sentiment, so that any increase or decrease in positive or negative moods over time can be measured relatively to the presence of the overall sentiments in this dataset. This approach makes PANAS-t very simple and practical to be used for large amounts of data and even for real-time analysis. To validate our approach, we extracted 10 real notable events that span a wide variety of issues spanning tragedies, technology releases, political debates, and healthcare from the 3.5 years worth of Twitter data, and demonstrated that PANAS- t can effectively capture the mood fluctuations during these events. The 10 events studied include the 2009 Presidential election in the US, death of the singer Michael Jackson, as well as the natural disasters like the 2010 Earthquake in Haiti. Our qualitative evaluation offers strong evidences that PANAS-t correctly captured expected sentiments for the analyzed events. The remainder of this paper is organized as follows. Section 2 surveys existing approaches to measure sentiments from text. Section 3 details how PANAS-t works and Section 4 describes the Twitter dataset. Section 5 provides experimental evidences that our approach is able to capture public mood from tweets associated to noteworthy events. Finally, Section 6 concludes the paper and offers directions for future work. I I . R ELAT ED WORK With the growth of social networking on web, sentiment analysis and opinion mining have become a subject of study for many researches. In this section, we survey different techniques used to measure sentiments from online text and describe related work that studied sentiments in Twitter. Several methodologies have being used by researchers to extract sentiment from online text. An overview of a num- ber of these approaches was well-presented in Pang and Lee’s survey [30], which covers several methods that use Natural Language Processing (NLP) techniques for sentiment analysis—techniques by which subjective properties of text are inferred using statistical methods. Those methods are usually suitable for constructing sentiment-aware and opinion mining Web applications, which analyze feedback of consumers or users about a particular product or service [3], [1]. Chesley et al. [10] utilized verbs and adjectives extracted from Wikipedia to classify text from blogs into three cate- gories: objective, subjective-positive, or subjective-negative. The verb classes used in the paper can express objectivity and polarity (i.e., a positive or negative opinion), and the polarity of adjectives can be drawn from their entries in the online dictionary, with high accuracy rates of two verb classes demonstrating polarity near 90%. More recently, Pak and Paroubek [29] utilized strategies of grammatical struc- tures’ recognition to define if a tweet written by a user is a subjective phrase or not. They demonstrated that superlative adjectives, verbs in first person, and personal pronouns are often used for expressing emotions and opinions as opposed to comparative adjectives, common, and proper nouns that are a strong indicator of an objective text. Other approaches that extract sentiment from online text rely on machine learning, a technique in which algorithms learn a classification model from a set of previously labeled data, and then apply the acquired knowledge to classify text new into sentiment categories. In [6], the authors use Support Vector Machine (SVM) and Multinomial Naive Bayes (MNB) classifiers to test whether brevity in microblog posts give any advantage in classifying sentiment and in fact find that short document length suggests a more compact and explicit sentiment than long document length. In [16], the authors use Random Walk (RW)-based model and compare it with SVM to predict bias in user opinions. Although these approaches are applicable for several scenarios, supervised learning tech- niques require manual intervention for pre-classifying training data, which may be infeasible for massive-scale social media data. Another line of research on extracting sentiments from online text is at measuring a happiness index from text [14]. Dodds and Danforth [13] proposed a method that computes the level of happiness of an unstructured text. They showed that while the happiness index inferred from song lyrics trends downward from the 1960s to the mid 1990s remained stable within genres, that of blogs has steadily increased from 2005 to 2009. While providing new insights, one drawback of this approach is that the happiness index proposed has a single scale and do not provide any other categorization of rich sentiments, which is the focus of this work. Miyoshi, T. [27] et al. propose a method to estimate the semantic orientation of Japanese reviews about some target products. Authors selected words that possible change the semantic orientation of a text and then concluded if the review of a product can be considered desirable or not. In order to evaluat their approach, authors analyzed 1,400 Japanese reviews of eletric products such as LCD and MP3 Players in order to separated it in positive and negative reviews. There are two studies that are more closely related to our goals. Kim et al. [23] proposed a method for detecting emotions using Affective Norms for English Words (ANEW), which is a dataset that contains normative emotional ratings for 1034 English words. Each word in the ANEW dataset is associated with a rating of 1–9 along each of three dimensions: valence, arousal, and dominance. Based on these scales, the authors examined sample tweets about celebrity deaths and found ANEW to be a promising tool mine Twitter data. Another study [7] utilized Profile of Mood States (POMS), which is a psychological rating scale that measures certain mood states consisting of 65 adjectives that qualify 6 negative feelings: tension, depression, anger, vigor, fatigue and confu- sion. The authors applied this scale to identify sentiments on a sample of tweets and evaluate the mood of users related to market fluctuations and events like political elections in the United States. This paper builds upon the above efforts and adopt a differ- ent psychometric scale called PANAS (Positive and Negative Affect Schedule) [35], [34] to achieve new contributions. First, compared to the machine learning-based or other dictionary- based approaches, PANAS contains a well-balanced set of both positive and negative affects. This makes PANAS suitable to analyze reactions of people not only on crisis events such as celebrity deaths and natural disasters, but also amusing events that incur positive emotions. Second, compared to existing work that tested sentiment extraction on sample data, we use the complete data gathered from Twitter to test the idea, which allows us to perform appropriate normalization to adjust PANAS for Twitter. I I I . PANAS - T: A FFEC T M EA SUR E FOR TW I T TER Our approach to measure sentiments in Twitter is rooted on a well-known psychometric scale, namely PANAS. We begin by describing PANAS-x, a popular expanded version of PANAS, which we utilize and then describe the normalization steps that we take to adapt the psychometric scale for Twitter. A. The PANAS and PANAS-x Scales The original PANAS consists of two 10-item mood scales and was developed by Watson and Clark [35] to provide brief measures of PA (Positive Affect) and NA (Negative Affect). Respondents are asked to rate the extent to which they have experienced each particular emotion within a specified time period (typically during the past week), with reference to a 5- point scale. Ever since the development of the test, the words appearing in the checklist broadly tapped the affective lexicon. Later, the same authors developed an expanded version by including 60 items. The expanded version, called PANAS-x, not only measures the two original higher order scales (PA and NA), but also 11 specific affects: Fear, Sadness, Guilt, Hostility, Shyness, Fatigue, Surprise, Joviality, Self-Assurance, Attentiveness, and Serenity. Table I summarizes the word composition of the PANAS- x scale [34]. The negative affect includes words like “afraid,” “scared,” and “nervous,” while the fatigue affect state includes words like “sleepy,” “tired,” and “sluggish.” The items in PANAS-x has been validated extensively and also is known to have strongly relationship with POMS categories, with con- vergent correlations ranging above 0.85. In addition, PANAS- x has been demonstrated with its excellence over POMS, because the items in PANAS-x tend to be less highly correlated with one another, and thus show better discriminant validity. For instance, the mean correlation among the PANAS-x Fear, Hostility, Sadness, and Fatigue scales was 0.45, which is significantly lower than the mean correlation (0.60) among the corresponding POMS scales. The authors also validated that individual trait scores on the PANAS-X scales (a) are stable over time, (b) show significant convergent and discriminant validity when correlated with peer-judgments, (c) are highly correlated with corresponding measures of aggregated state affect, and (d) are strongly and systematically related to measures of personality and emotionality [34]. Due to this excellence, we choose to adopt PANAS-x for analyzing short text updates from online social media. B. Adjusting PANAS-x for Twitter Tweets expressing certain sentiments may appear more fre- quently than others, leading to a bias or dominance of a small set of sentiments in OSN data. Thus, in order to tell if tweets expressing a specific type of sentiment has increased or decreased for a given event (e.g., celebrity death or natural disasters), we first need to know what kinds of sentiments appear during “typical” or non-event periods. Unfortunately, it is hard or impossible to determine which dates would be classified as such. One natural baseline would be to aggregate sentiments over a long period of time and consider the proportion of each type of sentiment as the baseline. Therefore, by comparing the proportion of tweets that contain a specific sentiment during a given event against the entire baseline, one can know how sentiments have changed related to the presence of a given event in the entire dataset. We describe the methods to compute the baselines for comparison. We assume each normalized tweet can be mapped to a single sentiment. When a tweet contains any of the adjectives in Table I, we associate the corresponding sentiment s as the main sentiment of the tweet. In case none of the sentiment words in Table I appear in a tweet, we cannot infer the sentiment for that tweet. This limitation is common to most other sentiment tools described in the related work. In case there is a tie and more than two sentiments can be found in a single tweet, we choose the first sentiment that appears in the tweet (based on the locatio of the adjectives) as the major sentiment of that tweet, although such ties are very rare and hence are negligible for analysis. The baseline sentiment can be then calculated as follows. Let T be the entire set of normalized tweets and Ts the subset of these tweets related to sentiment s. The baseline value for each sentiment, αs , is defined as the proportion that divides the number of occurrences of tweets of each type of sentiment by the total number of normalized tweets in our dataset: Ts T Table II shows the baseline values for all 11 sentiments in PANAS-x from the 3.5 years worth of Twitter data, which we will describe in detail in the next section. Some sentiments occur orders of magnitude more frequently than others. Tweets expressing fatigue occurs nearly 32 more frequently than tweets expressing shyness. This skew in frequency indicates that normalization is needed to comprehend the effective change of a given sentiment, because treating the any increase in the number of fatigue and shyness tweets equally will result in under-estimation and over-estimation of these sentiments, respectively. Therefore, the inherent skew in sentiments re- inforces that a proper normalization specific to the OSN is necessary. αs = (1) Sentiment (s) Fear Sadness Guilt Hostility Shyness Fatigue Surprise Joviality Self-assurance Attentiveness Serenity Baseline ( αs ) 0.0063791 0.0086279 0.0021756 0.0018225 0.0007608 0.0240757 0.0084612 0.0182421 0.0036012 0.0008997 0.0022914 Table II FRAC T ION O F TW E ET S FOR EACH S EN T IM EN T IN THE ENT IR E DATA SE T. Given the baseline sentiment values in Table II, we can now compute the relative increase or decrease in sentiments for a particular sample of tweets as follows. Let S be the set of General Dimension Scales Negative Affect (10) Positive Affet (10) Basic Negative Emotions Scales Fear (6) Hostility (6) Guilt (6) Sadness (5) Basic Positive Emotions Scales Joviality (8) Self-assurance (6) Attentiveness (4) Other Affective States Shyness (4) Fatigue (4) Serenity (3) Surprise (3) afraid, scared, nervous, jittery, irritable, hostile, guilty, ashamed, upset, distressed. active, alert, attentive, determined, enthusiastic, excited, inspired, interested, pround, strong. afraid, scared, frightened, nervous, jittery, shaky. angry, hostile, irritable, scornful, disgusted, loathing. guilty, ashamed, blameworthy, angry at self, disgusted with self, dissatisfied with self. sad, blue, downhearted, alone, lonely. happy, joyful, delighted, cheerful, excited, enthusiastic, lively, energetic. proud, strong, confident, bold, daring, fearless. alert, attentiveness, concentrating, determined. shy, bashful, sheepish, timid. sleepy, tired, sluggish, drowsy. calm, relaxed, at ease. amazed, surprised, astonished. Note. The number of terms comprising each scale is shown in parentheses. Table I I T EM COM PO S I T ION O F TH E PANAS-x SCA LE S . βs = P (s) = tweets (e.g., natural disaster) and Ss the subset of these tweets related to sentiment s. We define βs as the relative occurrence of sentiment s for the event S and compute it as follows: Ss S Finally, we define the PANAS-t score as an eleven-dimensional sentiment vector, where the PANAS-t score function P (s) for (cid:40) (αs−βs ) sentiment s is computed as bellow: αs − (βs−αs ) βs The value of P (s) varies between -1 and 1 for each sentiment s. An event with P (f ear) = 0 means that the event has no increase or decrease for the sentiment fear in comparison with the entire dataset of tweets posted as of 2009. A positive value of 0.3 would mean an increase of 30%, and so on. Our strategy to compute the PANAS-t score is simple and suitable for allowing the comparison of both the increase and decrease for each type of sentiment relatively to a non- bias dataset. More importantly, Table II provides a baseline for comparison against any kinds of sample tweets. For instance, one could easily crawl tweet samples using the Twitter API and normalize the sentiment scores found with our baselines. if βs ≤ αs otherwise (2) (3) category (appearing over 3.8 million times). Other popular words include “tired”, “excited”, “sad”, “amazed”, “alone”, and “surprised”, which all appear more than 1 million times. However, certain words in the PANAS-x scales are rarely used in Twitter to express the moods, such as “downherted” in the sadness category and “blameworth” in the guilt category. We may expect that not all words in the PANAS-x will appear frequently in OSNs, because the PANAS-x scale was originally designed to be used in a different environment (i.e., intrusive surveys). A patient submitted to PANAS test needs to mark in a scale from 1 to 5 how much each of these words tell about her mood state. Despite of this difference between PANAS-x and PANAS-t, the next section presents a number of situations in which PANAS-t can capture the expected mood states of populations about a number of noteworthy events accurately. IV. TW I T TER DATA SE T The dataset used in this work includes extensive data from a previous measurement study that included a complete snapshot of the Twitter social network and the complete history of tweets posted by all users as of August 2009 [8]. More specifically, the dataset contains 54,981,152 users who had 1,963,263,821 follow links among themselves and posted 1,755,925,520 tweets (as of August 2009). Out of all users, nearly 8% of the accounts were set as private, which implies that only their friends could view their links and tweets. We ignore these users in our analysis. This dataset is appropriate for the purpose of this work for the following reasons. First, the dataset contains all users with accounts created before August 2009. Thus, it is not based on sampling techniques that can introduce bias towards some characteristics of the users. Second, this dataset contains all tweets of these users, which is essential for measuring the increase or decrease of a certain sentiment related to tweets of a specific event. Thus, this dataset uniquely allows us to C. Most popular words of PANAS-t Having seen that the level of baseline sentiments in tweets are skewed, we quantify which words of the PANAS-t scales appear most frequently in the dataset. Table III shows the frequency of each adjective based on the entire Twitter data. Even within a given sentiment, certain adjectives are used more frequently to express feelings. The most popular adjectives are “sleepy” in the fatigue category (appearing over 8.0 million times), followed by “happy” in the joviality Self-assurance proud: 762,990 strong: 596,376 daring: 295,047 confident: 95,858 bold: 90,101 fearless: 20,084 Guilt ashamed: 492,371 guilty: 324,446 angry at self: 7,873 disgusted with self: 2,853 dissatisfied with self: 61 blameworthy: 19 Hostility angry: 483,937 irritable: 268,546 disgusted: 220,470 loathing: 72,330 hostile: 12,614 scornful: 7,516 Surprise amazed: 2,758,114 surprised: 1,050,164 astonished: 19,047 Attentiveness alert: 209,062 concentrating: 123,725 determined: 96,616 attentive: 5,456 Fatigue sleepy: 8,043,591 tired: 3,486,574 sluggish: 19,938 drowsy: 18,435 Sadness sad: 2,765,458 alone: 1,096,592 lonely: 15,858 blue: 987 downhearted: 286 Serenity at ease: 1,030,236 relaxed: 737,668 calm: 258,576 - Fear scare: 1,649,193 nervous: 668,867 afraid: 515,224 shaky: 173,142 frightened: 75,260 jittery: 12,791 Joviality happy: 3,802,662 excited: 3,170,837 delighted: 117,074 lively: 43,552 enthusiastic: 34,323 energic: 22,159 joyful: 21,663 cheerful: 19,178 Shyness shy: 320,611 timid: 13,521 bashful: 2,556 sheepish: 6,850 Table III FR EQU ENCY O F EACH TERM O F PANAS - T IN THE TOTA L DATABA SE . normalize the presence of sentiments of a sample of tweets relatively to the inherit sentiments in Twitter. A. Data cleaning steps In order to analyze only those tweets that possibly express individuals’ feelings, we only into account tweets that contain explicit statements of their author’s mood states by matching the following expressions in tweets: “I’m”, “I am”, “I”, “am”, “feeling”, “me” and “myself”. A similar approach has been used in [7] in finding correlations of Twitter moods and stock price. In total, we found 479,356,536 tweets that match these patterns, which correspond to about 27% of the entire dataset of tweets. Once we found a set of candidate tweets that contain emo- tions and moods, we further cleaned the data as follows. We first applied common language processing approaches such as case-folding, stemming, and removal of stop words, URLs, and common verb-forms. We then separated individual terms using white-space as delimiters and also removed commas, dashes, and others non-alphanumeric characters. For example, a tweet “I am so scared about swine flu” terns into the following set of terms, [I, am, scare, swine, flu]. In the remainder of this paper, we use the above described normalization and analyze a total of 479,356,536 normalized tweets. V. EVALUAT ION O F PANAS - T In order to evaluate the extent to which PANAS-t can accu- rately measure sentiments of Twitter users, we need ground truth data to compare the results with our methods. Such ground truth data is difficult to obtain because sentiments are subjective by nature. In this paper, we consider a few number of strategies to perform this evaluation. First we evaluate a set of popular events, for which the sentiments associated with them are expected or easy to be verified. Second, we compare our results obtained using PANAS-t with an analysis performed using common emoticons most used by users for express their feeling on social networkings. Third, we show that the baseline values computed for PANAS-t were useful to measure sentiments from a dataset of tweets collected in a different period. A. Testing across popular real-world events We picked nine events that were widely reported to have been covered by Twitter1 . These events, summarized in Table IV, span topics related to tragedies, products and movie releases, politics, health, as well as sport events. To extract tweets relevant to the these events, we first identified a set of keywords describing each topic by consulting news websites, blogs, wikipedia, and informed individuals. Given the selected list of keywords, we identified the topics by searching for keywords in the tweet dataset. We limited the duration of each event because popular keywords are typically hijacked by spammers after certain time [5], [11]. Table IV also displays the keywords used and the total number of tweets for each topic. In order to test how accurately PANAS-t can measure sentiment fluctuations, we calculated the PANAS-t scales for all events and present them in Kiviat representations. In each Kiviat graph, radial lines starting at the central point -1 represents each sentiment with the maximum value of 1 [22]. 1 Top Twitter trends http://tinyurl.com/yb4965e Event H1N 1 Duration Mar 1 – Jul 31, 2009 A IRFRANC E Jun 1–6, 2009 US -E LEC Nov 2–6, 2008 OBAMA M ICHA E L - JACK SON SU SAN -BOYL E HARRY- POTT ER O LYM P IC S SAMOA HA I T I 18–22, 25–30, Jan 2009 Jun 2009 13–17, 11–16, Apr 2009 Jul 2009 Aug 2008 Sep 28 – Oct 4, 2009 Jan 2010 6–26, 11–17, Description (Example keywords) Disease outbreak (tamiflu, outbreak, influenza, pan- demia, pandemic, h1n1, swine, world health organi- zation) A plane crash (victims, passengers, A330, 447, crash, airplane, airfrance) US presidential election (clinton, biden, palin, vote, mccain, democrat, republican, obama) Presidential inauguration speech (barack obama, white house, presidential, inauguration) Death of celebrity (rip, mj, michael jackson, death, king of pop, overdose, drugs, heart attack, conrad murray) Appearance of a new celebrity (susan boyle, dreamed a dream, britain’s got talent) Release of a movie (harry potter, half-blood prince, rowling) Beijing Olympics (olympics, medals, china, beijing, sports, peking, sponsor) Natural disaster (tsunami, samoa islands, earthquake) Natural disaster (haiti, earthquake, richter, port au prince, jacmel, leogane) tonga, I # Tweets 335,969 29,765 185,477 43,015 56,259 7,142 194,356 12,815 23,881 236,096 Table IV SUMMARY O F EV EN T S THAT W ER E ANALYZ ED . In Figure V-A, we plot the eleven sentiments in each figure so that each figure represents the corresponding event. The first event we examine is H1N1, which represents the worldwide disease outbreak of the H1N1 influenza. The marking date, March 1st of 2009 was the day, where the influenza was declared by World Health Organization (WHO) as the global pandemic. To identify the event, we searched for a number of keywords including “pandemic” and “swine” and found a total of 335,969 relevant tweets during the five months period. Figure 1(a) shows the sentiment scores of this event based on PANAS-t scales. It demonstrates that the emotional state of Twitter users increased in attentiveness (P(s) = 0.8774) and fear (P(s) = 0.6768) in the days just after the announcement. Indeed, these two feelings correspond to the most likely feelings to expect from this event as people were both attentive to the precautions as well as afraid of a global pandemic. is A IRFRANC E, which describes the The second event tragic crash of an airplane on July 1st, 2009, which caused a big commotion in Twitter. The AirFrance Flight 447 was a scheduled as commercial flight from Rio de Janeiro to Paris, but crashed in Ocean and killed all the 216 passengers. As expected, the crash caused sad emotions towards those who died and also fear that a something similar might happen again. Figure 1(b) shows the Kiviat representation for this event. As expected, fear (P(s) = 0.72914) and sadness (P(s) = 0.6992) were the two most predominated feelings in the tweets associated to this event. The third event is US -E LEC, which describes the presi- dential election related tweets in the US. With the election, many voters might feel apprehensive and even excited about the power of choice that is given to them. Our results show sentiments on this direction. Figure 1(c) shows that users had the feeling for self-assurance (P(s) = 0.6741), joviality (P(s) = 0.4277) and fear (P(s) = 0.3072) increased, when the election results came out. The fourth event, OBAMA, describes the president Barack Obama’s inauguration speech, which received wide attention in Twitter. As reported in reference [17], the majority of Americans were more confident in the improvement of the country after viewing President Barack Obama’s inauguration speech. Our analysis of the mood of Twitter’s users performed on the day of Obama’s speech shows a particularly large increase in self-assurance’s (P(s) = 0.7980), followed by surprise (P(s) = 0.5802), and joviality (P(s) = 0.5227 ). But despite all the positive manifestation regarding the election of Obama, we can also see a positive, but not so high value for sadness (P(s) = 0.1789), which might naturally represent tweets from Barack Obama’s oppositors. Figure 1(d) shows that the feelings measured with PANAS-t are agreement with the ones reported in reference [17]. The fifth Kiviat chart, M ICHA E L - JACK SON, is about the death of singer Michael Jackson. According to DailyMail [4], nine of the ten most popular topics in Twitter were dedicated to the event the day after his death. In Figure 1(e), we can see an increase in sadness (P(s) = 0.4055), fear (P(s) = 0.5676), shyness (P(s) = 0.4055), guilt (P(s) = 0.1616), and surprise (P(s) = 0.0810). It is interesting to perceive that, in addition to the expected feelings associated with a sudden death like sadness and fear, we could see increase in guilt. This may be explained by the fact that many speculated about who or what killed Michael Jackson and fans and critics blamed the high stress caused by paparazzi and media for the death of celebrity. Therefore, some Twitter users felt guilt for his death and expressed such feeling in their tweets. The next event we analyze is SU SAN -BOYL E, who’s appear- ance as a contestant the TV show, Britain’s Got Talent, had an incredible repercussion in the media. Global interest was triggered by the contrast between her powerful voice singing “I Dreamed a Dream” from the musical Les Miserables and (a) H1N1 (b) AirFrance (c) US-Elec (d) Obama (e) MJ-death (f) Susan-Boyle (g) Harry-Potter (h) Olympics-begin (i) Olympics-end Figure 1. Events and feelings associated with them using PANAS-t. her plain appearance on stage. The contrast of the audience’s first impression of her, with the standing ovation she received during and after her performance, led to an immediate viral spread over the social networks and a huge attention of the global media. Figure 1(f) shows that the sentiments expressed in Twitter associated with Susan Boyle’s first appearance are surprise (P(s) = 0.9066), followed by self-assurance (P(s) = 0.4751), and guilt (P(s) = 0.1367). The high surprise factor could also explain why Susan Boyle’s video went viral on the Internet. People also felt self-assured as it is encouraging to see a woman successfully facing an audience that is laughing at her. Finally, guilt is also expected as the event is based on wrong prejudice based on appearance. The seventh event we studied is HARRY-POTT ER, which describes the release of the movie “Harry Potter and the Half-Blood Prince”. Figure 1(g) shows that the main feelings associated are joviality (P(s) = 0.6355), surprise (P(s) = 0.4926), and sadness (P(s) = 0.2056), which also is described by many other critics that say the movie will leave the audience “pleased, amused, excited, scared, infuriated, delighted, sad, surprised, and thoughtful.” The last two charts shown in the figure are related to the O LYM P IC S games that were held in the summer of 2008 in Beijing, China. For this event, we show two Kiviat charts: one drawn based on the beginning sentiments and the other based on the ending sentiments of the event. Figure 1(h) is based on sentiments from the day of opening ceremony on August 08, where people felt surprise (P(s) = 0.7024), attentiveness (P(s) = 0.4621), and joviality (P(s) = 0.3298). However, in the end of the event, on August 24th, we can see that these feelings had a decrease, whereas sadness increased from P(s)= 0.1222 in this day and to P(s) = 0.5245 in the next day, as we can see in Figure 1(i). B. Testing across different geographical regions In order to evaluate whether PNAS-t can effectively capture the subtle sentiment differences across different geographical areas, we take the example of the popular H 1N1 event and examine how sentiments on the event fluctuate over time in two different regions: USA and Europe. To give further context of the H 1N1 event, we start by describing its impact on society. The H1N1 influenza, or also known as the “swine flu” by the public, has killed as many as half a million people in 2009. The World Health Organization (WHO) declare it as the first global pandemic since the 1968 Hong Kong flu, which caused a large concern in the world population. Later, WHO launched several warnings and precautions that should be taken by governments and by public, taking the entire population to a state of world alert against the disease. In this section we compare the fluctuations of the mood of users about H1N1 in two different locations. More specifically, we want to verify how USA and European Twitter users felt about the event and quantify differences in public mood according to geographic regions. In examining the difference in sentiments across North America and Europe, we focus on only English tweets. There- fore sentiments in Europe are limited to those tweets residing from Europe written in English. To be consistent in language representativeness, we limited our focus to tweets residing from the following regions in Europe: Ireland, Kingdom of the Netherlands, Malta, and United Kingdom. To do this we used a database collected and used in reference [24]. In this paper, authors used an expressive database from Twitter to separate unique ids, that represents users, by location. The sparkline charts shown in Figures 2(a) and 2(b) present the fluctuations of four of the major sentiments related to the event in PANAS-t scales for Europe and USA, respectively. The charts are marked with five dates that indicate the day of important announcements made by WHO. In March, Mexican authorities begin picking up cases of what WHO called an “influenza-like-illness.” This event led European users to have an increase in the feeling of surprise (P(s) = 0.8730) but the same did not happen with users in the US. In April, the first case of H1N1 in the United States was confirmed and WHO issued a health advisory on the outbreak of “influenza like illness in the United States and Mexico”, and the charts shown a similar increase in fear in both locations, P(s) = 0.7401 for Europe and P(s) = 0.6154 for the US. We also see an increase in attentiveness, but this trend is only for Europe (P(s) = 0.4423). In June, WHO declared the new strain of swine-origin H1N1 as a pandemic, causing an increase of fear (P(s) = 0.5385) but also in attentiveness in the US (P(s) = 0.3491) and in users from Europe (P(s) = 0.3174). In July, 26,089 new cases of H1N1 were confirmed in Europe by WHO, which leads to a further increase in sentiment of fear (P(s) = 0.4887 ), mainly among the European users. the most affected On the last marked date in August, countries and deaths were announced as being located in Europe and America [19]. In this period, European users had an increase in feeling of hostility (P(s) = 0.2542), whereas users in the US increased the feeling of fear (P(s) = 0.4112). These variations in the degree of sentiments expressed over time can effectively capture the dynamics in people’s moods across different geographical regions. C. Testing across different time periods The baseline values computed for PANAS-t in Table II is based on longitudinal data, based on 3.5 years worth of tweets (a) H1N1-Europe (b) H1N1-US Figure 2. Public mood for H1N1 over 2009 in Europe and U.S. between 2006 and until mid 2009, and represent a rather stable base sentiment of Twitter users. Therefore, these baseline values can be used to detect feelings of Twitter users from much later time periods (beyond mid 2009). Here, we use a different Twitter dataset that contains tweets posted between the end of 2009 to the end of 2010 that was collected by [26] and have extracted tweets associated with two last events in Table IV: SAMOA and HA I T I. The 2009 SAMOA Islands Tsunami was caused by a sub- marine earthquake that took place in the Samoan Islands on September 29th with a magnitude of 8.1, which was the largest earthquake of 2009. A tsunami was generated causing substantial damage and loss of life in Samoa, Amer- ican Samoa, and Tonga. More than 189 people were killed including children, which caused a large commotion around the world and generated a state of alert in neighboring coastal countries [18]. Figure 3(a) shows the Kiviat chart for mood of users on the day of tsunami and the day after, which shows dominance in feelings of fear (P(s) = 0.9280), attentiveness (P(s) = 0.9932), hostility (P(s) = 0.8451), surprise (P(s) = 0.6528), and sadness (P(s) = 0.6483). A similar tragic event happened in three months later in another part of the world. The 2010 HA I T I earthquake was a catastrophic natural disaster, which caused severe damage in Port-au-Prince and the nearby region killing at least 250,000 people. Figure 3(b) shows that feelings of hostility (P(s) = 0.9280), attentiveness (P(s) = 0.3678), surprise (P(s) = 0.4576) and sadness (P(s) = 0.3975) had an increase. We also see an increase in shyness and guilt. After this event the world’s eyes were focused on the disaster and people networks. From the researcher perspective our method would allow one to comprehend how, when, and why individuals feel and their feelings fluctuate according to social and economic events. Despite the new opportunities our work brings, there are several limitations. First, the tweets we examined do no represent everyone who expressed sentiments in Twitter. We only focused on those tweets that explicitly contained “I am feeling” kinds of tags, although other tweets may contain emotions as well. Nonetheless, classifying emotional content from informational content remains an important challenge in social media analysis. Second, one criticism of sentiment analysis is that it takes a naive view of emotional states, assuming that personal moods can simply be divined from word selection. This might seem particularly perilous on a medium like Twitter, where sarcasm and other playful uses of language may subvert the surface meaning of a tweet. Deeper linguistic analysis should be explored to provide “a richer and a more nuanced view” of how people present themselves to the world. We expect that in the future more applications will utilize sentiment analysis for specific vocabularies especially in a dy- namic environment like Twitter to understand people’s moods. Thus, we plan to combine other techniques such as machine learning to dynamically incorporate sentiments to PANAS-t according to the context. R E F ER ENC E S [1] E. M. Airoldi, X. Bai, R. Padman, Markov blankets and meta-heuristic search: Sentiment extraction from unstructured text, Lecture Notes in Computer Science 3932 (Advances in Web Mining and Web Usage Analysis) (2006) 167–187. [2] S. Asur, B. A. Huberman, Predicting the future with social media, CoRR abs/1003.5699. [3] A. Aue, M. Gamon, Customizing sentiment classifiers to new domains: A case study, in: Proceedings of Recent Advances in Natural Language Processing (RANLP), 2005. [4] C. Bates, How michael jackson’s death shut down twitter, brought chaos to google...and ’killed off ’ jeff goldblum, http://bit.ly/16e6eM, accessed January, 2012. [5] F. Benevenuto, G. Magno, T. Rodrigues, V. Almeida, Detecting spam- mers on twitter, in: Proceedings of the Annual Collaboration, Electronic messaging, Anti-Abuse and Spam Conference (CEAS), 2010. [6] A. Bermingham, A. F. Smeaton, Classifying sentiment in microblogs: is brevity an advantage?, in: Proceedings of the 19th ACM international conference on Information and knowledge management, 2010. [7] J. Bollen, A. Pepe, H. Mao, Modeling public mood and emotion: Twitter sentiment and socio-economic phenomena, in: Proceedings of the International AAAI Conference on Weblogs and Social Media (ICWSM), 2011. [8] M. Cha, H. Haddadi, F. Benevenuto, K. P. Gummadi, Measuring User Influence in Twitter: The Million Follower Fallacy, in: Proceedings of the International AAAI Conference on Weblogs and Social Media (ICWSM), 2010. [9] M. Cheong, V. C. Lee, A microblogging-based approach to terrorism informatics: Exploration and chronicling civilian sentiment and response to terrorism events via twitter, Information Systems Frontiers 13 (2011) 45–59. [10] P. Chesley, B. Vincent, L. Xu, R. Srihari, Using verbs and adjectives to automatically classify blog sentiment, in: AAAI Symposium on Com- putational Approaches to Analysing Weblogs (AAAI-CAAW), 2006. [11] S. Chhabra, A. Aggarwal, F. Benevenuto, P. Kumaraguru, Phi.sh/$ocial: The phishing landscape through short urls, in: Proceedings of the 8th Annual Collaboration, Electronic messaging, Anti-Abuse and Spam Conference (CEAS), 2011. [12] N. A. Diakopoulos, D. A. Shamma, Characterizing debate performance via aggregated twitter sentiment, in: Proceedings of the 28th interna- tional conference on Human factors in computing systems, 2010. (a) Samoa (b) Haiti Figure 3. Feeling expressed by Twitter’s users for Tsunami, in Samoa Islands, and Earthquake, in Haiti. around the world offered help to Haiti [20]. As the poverty and precarious situation of the Haiti people was unveiled in the news, it is possible that this situation has generated an increase of these two feelings among the Twitter users. This finding demonstrates that PNAS-t is stable and can effectively represent sentiments of tweets gathered much later in time. V I . CONC LU S ION S In this paper, we present PANAS-t an eleven-sentiment psy- chometric scale adapted to the context of Twitter. PANAS-t is based on the expanded version of the well known Positive Affect Negative Affect Scale (PANAS-x). Using empirical data from a unique Twitter dataset containing 1.8 billion tweets, we were able to compute the normalization scores for each sentiment. We conducted a three-step evaluation. We first applied PANAS-t to 11 notable events that were widely discussed in Twitter. We next compared PANAS-t with a method using most common emoticons that are used for users in Web. We finally showed that our method can be used in other database and also in other periods. These results provide strong evidences that PANAS-t can accurately capture the positive and negative sentiments about events in Twitter. The normalized scores of sentiments provided in this paper allow anyone to easily use PANAS-t, making it very simple and practical to be used for large amounts of data and even for real-time analysis. We hope that this psychometric scale can be used by any researches with the purpose of create tools that can be used for government agencies or companies that might be interested in improving their products using social [13] P. Dodds, C. Danforth, Measuring the happiness of large-scale written expression: Songs, blogs, and presidents, Journal of Happiness Studies 11 (2010) 441–456. [14] S. A. Golder, M. W. Macy, Diurnal and seasonal mood vary with work, sleep, and daylength across diverse cultures, Science 333 (6051) (2011) 1878–1881. [15] J. Gomide, A. Veloso, W. M. Jr., V. Almeida, F. Benevenuto, F. Ferraz, M. Teixeira, Dengue surveillance based on a computational model of spatio-temporal locality of twitter, in: Proceedings of the ACM Web Science Conference (WebSci), 2011. [16] P. H. C. Guerra, A. Veloso, W. Meira, Jr, V. Almeida, From bias to opinion: a transfer-learning approach to real-time sentiment analysis, in: Proceedings of the ACM SIGKDD Conference on Knowledge Discovery and Data Mining (KDD), 2011. [17] HCD, Confidence levels increase among democrats and indepen- dents, decrease among republicans after viewing obama’s press con- ference, http://www.hcdi.net/news/MediacurvesRelease.cfm?M=276, ac- cessed January 15, 2012. [18] Fear for new tsunami after earthquake hits sumatra, http://digitaljournal. com/article/279868. [19] Map of affected countries and deaths as of 23 august 2009, http://www. who.int/csr/don/2009 08 28/en/index.html. responds [20] Operation earthquake haitian to compassion victims, http://www.operationcompassion.org/2010/01/ operation- compassion- responds- to- haitian- earthquake- victims/. [21] US confirms it asked Twitter to stay open to help Iran protesters, http: //tinyurl.com/klv36p. [22] R. Jain, The Art of Computer Systems Performance Analysis: Tech- niques for Experimental Design, Measurement, Simulation, and Model- ing, 1st ed., John Wiley and Sons, INC, 1991. [23] B. E. Kim, S. Gilbert, Detecting sadness in 140 characters: Sentiment analysis and mourning michael jackson on twitter, Web Ecology 03 (2009) 1–15. [24] J. Kulshrestha, F. Kooti, A. Nikravesh, K. P. Gummadi, Geographic dissection of the twitter network, in: Proceedings of the International AAAI Conference on Weblogs and Social Media (ICWSM), 2012. [25] D. Lazer, A. Pentland, L. Adamic, S. Aral, A. l ´aszl ´o Barab ´asi, D. Brewer, N. Christakis, N. Contractor, J. Fowler, M. Gutmann, T. Jebara, G. King, M. Macy, D. Roy, M. V. Alstyne, Computational social science, Science 323 (5915) (2009) 721–723. [26] P. J. Michael, M. Dredze, You are what you tweet: Analyzing twitter for public health, in: Proceedings of the International AAAI Conference on Weblogs and Social Media (ICWSM), 2011. [27] T. Miyoshi, Y. Nakagami, Sentiment classification of customer reviews on electric products, International Symposium in Information Technol- ogy (ITSim) (2007) 2028–2033. [28] B. O’Connor, R. Balasubramanyan, B. R. Routledge, N. A. Smith, From tweets to polls: Linking text sentiment to public opinion time series, in: Proceedings of the International AAAI Conference on Weblogs and Social Media (ICWSM), 2010. [29] A. Pak, P. Paroubek, Twitter as a corpus for sentiment analysis and opin- ion mining, in: N. C. C. Chair), K. Choukri, B. Maegaard, J. Mariani, J. Odijk, S. Piperidis, M. Rosner, D. Tapias (eds.), Proceedings of the Seventh International Conference on Language Resources and Evalua- tion (LREC), European Language Resources Association (ELRA), 2010. [30] B. Pang, L. Lee, Opinion mining and sentiment analysis, Foundations and Trends in Information Retrieval 2 (2008) 1–135. [31] J. W. Pennebaker, M. R. Mehl, K. G. Niederhoffer, Psychological aspects of natural language use: Our words, ourselves, Annual Review of Psychology 54 (2003) 547–577. [32] T. Sakaki, M. Okazaki, Y. Matsuo, Earthquake shakes twitter users: real-time event detection by social sensors, in: Proceedings of the International Conference on World Wide Web (WWW), 2010. [33] A. Tumasjan, T. O. Sprenger, P. G. Sandner, I. M. Welpe, Predicting elections with twitter: What 140 characters reveal about political senti- ment, in: Proceedings of the International AAAI Conference on Weblogs and Social Media (ICWSM), 2010. [34] D. Watson, L. A. Clark, The PANAS-X: Manual for the positive and negative affect schedule-Expanded Form, University of Iowa, 1994. [35] D. Watson, L. A. Clark, A. Tellegen, Development and validation of brief measures of positive and negative affect: the PANAS scales, Journal of Personality and Social Psychology 54 (1988) 1063–1070. [36] K. Wickre, Celebrating twitter7, http://blog.twitter.com/2013/03/ celebrating- twitter7.html, accessed on May 16, 2013.
1703.07518
1
1703
2017-03-22T04:37:39
Early Detection of Promoted Campaigns on Social Media
[ "cs.SI" ]
Social media expose millions of users every day to information campaigns --- some emerging organically from grassroots activity, others sustained by advertising or other coordinated efforts. These campaigns contribute to the shaping of collective opinions. While most information campaigns are benign, some may be deployed for nefarious purposes. It is therefore important to be able to detect whether a meme is being artificially promoted at the very moment it becomes wildly popular. This problem has important social implications and poses numerous technical challenges. As a first step, here we focus on discriminating between trending memes that are either organic or promoted by means of advertisement. The classification is not trivial: ads cause bursts of attention that can be easily mistaken for those of organic trends. We designed a machine learning framework to classify memes that have been labeled as trending on Twitter.After trending, we can rely on a large volume of activity data. Early detection, occurring immediately at trending time, is a more challenging problem due to the minimal volume of activity data that is available prior to trending.Our supervised learning framework exploits hundreds of time-varying features to capture changing network and diffusion patterns, content and sentiment information, timing signals, and user meta-data. We explore different methods for encoding feature time series. Using millions of tweets containing trending hashtags, we achieve 75% AUC score for early detection, increasing to above 95% after trending. We evaluate the robustness of the algorithms by introducing random temporal shifts on the trend time series. Feature selection analysis reveals that content cues provide consistently useful signals; user features are more informative for early detection, while network and timing features are more helpful once more data is available.
cs.SI
cs
Early Detection of Promoted Campaigns on Social Media Onur Varol1, Emilio Ferrara2∗, Filippo Menczer1, Alessandro Flammini1 1 School of Informatics and Computing, Indiana University 2 Information Sciences Institute, University of Southern California Abstract Social media expose millions of users every day to information campaigns - some emerging organically from grassroots activity, others sustained by advertising or other coordinated efforts. These campaigns contribute to the shaping of collective opinions. While most information campaigns are benign, some may be deployed for nefarious purposes, including terrorist propaganda, political astroturf, and financial market ma- nipulation. It is therefore important to be able to detect whether a meme is being artificially promoted at the very moment it becomes wildly popular. This problem has important social implications and poses numerous technical challenges. As a first step, here we focus on discriminating between trending memes that are either organic or promoted by means of advertisement. The classification is not trivial: ads cause bursts of attention that can be easily mistaken for those of organic trends. We designed a machine learning framework to classify memes that have been labeled as trending on Twitter.After trending, we can rely on a large volume of activity data. Early detec- tion, occurring immediately at trending time, is a more challenging problem due to the minimal volume of activity data that is available prior to trending.Our supervised learning framework exploits hundreds of time-varying features to capture changing net- work and diffusion patterns, content and sentiment information, timing signals, and user meta-data. We explore different methods for encoding feature time series. Using millions of tweets containing trending hashtags, we achieve 75% AUC score for early detection, increasing to above 95% after trending. We evaluate the robustness of the algorithms by introducing random temporal shifts on the trend time series. Feature selection analysis reveals that content cues provide consistently useful signals; user fea- tures are more informative for early detection, while network and timing features are more helpful once more data is available. 1 Introduction An increasing number of people rely, at least in part, on information shared on social me- dia to form opinions and make choices on issues related to lifestyle, politics, health, and ∗Corresponding author: [email protected] 1 products purchases [4, 11, 60]. Such reliance provides a variety of entities - from single users to corporations, interest groups, and governments - with motivation to influence collective opinions through active participation in online conversations. There are also obvious incentives for the adoption of covert methods that enhance both perceived and actual popularity of promoted information. There are abundant recently reported exam- ples of abuse: astroturf in political campaigns, or attempts to spread fake news through social bots under the pretense of grassroots conversations [64, 30, 9]; pervasive spreading of unsubstantiated rumors and conspiracy theories [8]; orchestrated boosting of perceived consensus on relevant social issues performed by governments [67]; propaganda and recruit- ment by terrorist organizations, like ISIS [6, 32]; and actions involving social media and stock market manipulation [73]. The situation is ripe with dangers as people are rarely equipped to recognize propaganda or promotional campaigns as such. It can be difficult to establish the origin of a piece of news, the reputation of its source, and the entity behind its promotion on social media, due both to the intrinsic mechanisms of sharing and to the high volume of information that competes for our attention. Even when the intentions of the promoter are benign, we easily interpret large (but possibly artificially enhanced) popularity as widespread endorsement of, or trust in, the promoted information. There are at least three questions about information campaigns that present scientific challenges: what, how, and who. The first concerns the subtle notion of trustworthiness of information, ranging from verified facts [18], to rumors and exaggerated, biased, unverified or fabricated news [64, 85, 8]. The second considers the tools employed for the propaganda. Again, the spectrum is wide: from a known brand that openly promotes its products by targeting users that have shown interest, to the adoption of social bots, trolls and fake or manipulated accounts that pose as humans [74, 30, 26, 20, 37]. The third question relates to the (possibly concealed) entities behind the promotion efforts and the transparency of their goals. Even before these question can be explored, one would need to be able to identify an information campaign in social media. But discriminating such campaigns from grassroots conversations poses both theoretical and practical challenges. Even the very definition of "campaign" is conceptually difficult, as it entangles the nature of the content (e.g., product or news), purpose of the source (e.g., deception, recruiting), strategies of dissemination (e.g., promotion or orchestration), different dynamics of user engagement (e.g., the aforementioned social bots), and so on. This paper takes a first step toward the development of computational methods for the early detection of information campaigns. In particular, we focus on trending memes and on a special case of promotion, namely advertisement, because they provide conve- nient operational definitions of social media campaigns. We formally define the task of discriminating between organic and promoted trending memes. Future efforts will aim at extending this framework to other types of information campaign. 2 Table 1: Summary statistics of collected data about promoted and organic trends on Twitter. Promoted Organic Dates No. trends Avg. no. tweets Avg. no. unique users Avg. retweet ratio Avg. reply ratio Avg. no. urls Avg. no. hashtags Avg. no. mentions Avg. no. words 1 Jan– 31 Apr 2013 1–15 Mar 2013 mean 2,385 2,090 42% 7.5% 0.25 1.7 0.8 13.5 75 st. dev. 6,138 5,050 13.8% 7.8% 0.176 0.33 0.28 2.21 852 mean st. dev. 3,692 2,828 33% 20% 0.15 1.7 0.9 12.2 9,720 8,240 18.6% 21.8% 0.149 0.78 0.35 2.74 1.1 The challenge of identifying promoted content On Twitter, it is common to observe hashtags - keywords preceded by the # sign that identify messages about a specific topic - enjoying sudden bursts in activity volume due to intense posting by many users with an interest in the topic [45, 84, 58]. Such hashtags are labeled as trending and are highlighted on the Twitter platform. Twitter algorithmically identifies trending topics in a predetermined set of geographical locations. Although Twit- ter recently included personalized and clustered trends, the ones in the collection analyzed here correspond to single hashtags selected on the basis of their popularity. Unfortunately, detailed knowledge about the algorithm and criteria used to identify organic trends is not publicly available [72]. Other hashtags are exposed prominently after the payment of a fee by parties that have an interest in enhancing their popularity. Such hashtags are called promoted and often enjoy subsequent bursts of popularity similar to those of trending hashtags, therefore being listed among trending topics. Of course, once Twitter labels a hashtag as trending, it is not necessary to detect whether or not it is promoted - this information is disclosed by Twitter. However, since it is difficult to manually annotate a sufficiently large datasets of campaigns, we use organic and promoted trending topics as a proxy for a broader set of campaigns, where promotion mechanisms may be hidden. Our data collection methodology provide us with a large source of reliable "ground truth" labels about promotion, which represent an ideal testbed to evaluate detection algorithms. These algorithms have to determine whether or not a hashtag is promoted based on information that would be available even in cases where the nature of a trend is unknown. We stress that our goal of distinguishing mechanisms for promoting popular content is different from that of predicting viral topics, an interesting area of research in its own right [79, 15, 16]. 3 Figure 1: Time series of trending hashtags. Comparison of the time series of the volume (number of tweets per hour in our sample) relative to promoted (left) and organic (right) trends with similar temporal dynamics. Discriminating between promoted and organically trending topics is not trivial, as Ta- ble 1 illustrates - promoted and organic trending hashtags often have similar character- istics. One might assume that promoted trends display volume patterns characteristic of exogenous influence, with sudden bursts of activity, whereas organic trends would con- form to more gradual volume growth patterns typical of endogenous processes [68, 59, 45]. However, Fig. 1 shows that promoted and organic trends exhibit similar volume patterns over time. Furthermore, promoted hashtags may preexist the moment in which they are given the promoted status and may have originated in an entirely grassroots fashion. It is therefore conceivable for such hashtags to display features that are largely indistinguishable from those of other grassroots hashtags about the same topic, at least until the moment of promotion. The analysis in this paper is motivated by the goal of identifying promoted campaigns at the earliest possible time. The early detection task addresses the difficulty of judging the nature of a hashtag using only the limited data available immediately before trending. Fig. 2 illustrates the shortage of information available for early detection. It is also con- ceivable that once the promotion has triggered interest in a hashtag, the conversation is sustained by the same mechanisms that characterize organic diffusion. Such noise around popular conversations may present an added difficulty for the early detection task. 1.2 Contributions and outline The major contribution of this paper, beyond formulating the problem of detection of cam- paigns in social media, is the development and validation of a supervised machine learning framework that takes into consideration the temporal sequence of messages associated with a trending hashtag on Twitter and successfully classifies it as either "promoted" (adver- tised) or "organic" (grassroots). The proposed framework adopts time-varying features built from network structure and diffusion patterns, language, content and sentiment in- In the following sections we discuss the formation, timing signals, and user meta-data. 4 Figure 2: Cumulative fraction of tweets as a function of time. On average, only 13% of the tweets in the organic class and 15% of the tweets in the promoted class are produced prior to the trending point. The majority of tweets are observed after the trending point, with a rapid increase around trending time. data we collected and employed, the procedure for feature extraction and selection, the implementation of the learning framework, and the evaluation of our system. 2 Data and methods 2.1 Dataset description The dataset adopted in this study consists of Twitter posts (tweets) that contain a trending hashtag and appeared during a defined observation period. Twitter provides an interface that lists trending topics, with clearly labeled promoted trends at the top (Fig. 3). We crawled the Twitter webpage at regular intervals of 10 minutes to collect all organic and promoted hashtags trending in the United States between January and April 2013, for a total of N = 927 hashtags. This constitutes our ground-truth dataset of promoted and organic trends. We extracted a sample of organic trends observed during the first two weeks of March 2013 for our analysis. While Twitter allows for at most one promoted hashtag per day, dozens of organic trends appear in the same period. As a result, our dataset is highly imbalanced, with the promoted class more than ten times smaller than the the organic 5 Figure 3: Screenshot of Twitter U.S. trends taken on Jan. 6, 2016. The hashtag #CES2016 was promoted on this date. one (cf. Table 1). Such an imbalance, however, reflects our expectation to observe in the Twitter stream a minority of promoted conversations blended in a majority of organic content. Therefore we did not balance the classes by resampling, to study the campaign detection problem under realistic conditions. Hashtags may trend multiple times on Twitter. However, those in our collection only trended once during our observation period. For each trend, we retrieved all tweets con- taining the trending hashtag from an archive containing a 10% random sample of the public Twitter stream. The collection period was hashtag-specific: for each hashtag we obtained all tweets produced in a four-day interval, starting two days before its trending point and extending to two days after that. This procedure provides an extensive coverage of the temporal history of each trending hashtag in our dataset and its related tweets, allowing us to study the characteristics of each trend before, during, and after the trending point. Given that each trend is described by a collection of tweets over time, we can aggregate data in sliding time windows [t, t + (cid:96)) of duration (cid:96) and compute features on the subsets of tweets produced in these windows. A window can slide by time intervals of duration δ. The next window therefore contains tweets produced in the interval [t + δ, t + (cid:96) + δ). We experimented with various time window lengths and sliding parameters, and the optimal performance is often obtained with windows of duration (cid:96) = 6 hours sliding by δ = 20 minutes. We have made the IDs of all tweets involved in the trending hashtags analyzed in this paper available in a public dataset.1 2.2 Features Our framework computes features from a collection of tweets in some time interval. The system generates 487 features in five different classes: network structure and information 1carl.cs.indiana.edu/data/ovarol/trend-dataset.tar.gz 6 Class Network(†) User Timing Content Sentiment Feature description Number of nodes Number of edges (*) Strength distribution (*) In-strength distribution (*) Out-strength distribution (*) Distribution of number of nodes in the connected components Network density of whole and largest connected component Network assortativity of whole and largest connected component Mean shortest path length of the largest connected component (*) Sender's follower count (*) Sender's followee count (*) Sender's number of favorite tweets (*) Sender's number of Twitter statuses posted (*) Sender's number of lists subscribed to (*) Originator's follower count (*) Originator's followee count (*) Originator's number of favorite tweets (*) Originator's number of Twitter statuses posted (*) Originator's number of lists subscribed to Number of tweets appeared in a given window (*) Time between two consecutive tweets (*) Time between two consecutive retweets (*) Time between two consecutive mentions (*) Number of hashtags in a tweet (*) Number of mentions in a tweet (*) Number of URLs in a tweet (*,**) Frequency of POS tags in a tweet (*,**) Proportion of POS tags in a tweet (*) Number of words in a tweet (*) Entropy of words in a tweet (***) Happiness scores of aggregated tweets (***) Valence scores of aggregated tweets (***) Arousal scores of aggregated tweets (***) Dominance scores of single tweets (*) Happiness score of single tweets (*) Valence score of single tweets (*) Arousal score of single tweets (*) Dominance score of single tweets (*) Polarization score of single tweets (*) Entropy of polarization scores of single tweets (*) Positive emoticons entropy of single tweets (*) Negative emoticons entropy of single tweets (*) Emoticons entropy of single tweets (*) Ratio between positive and negative score of single tweets (*) Number of positive emoticons in single tweets (*) Number of negative emoticons in single tweets (*) Total number of emoticons in single tweets Ratio of tweets that contain emoticons 1 1 8 8 8 8 2 2 1 8 8 8 8 8 8 8 8 8 8 1 8 8 8 8 8 8 64 64 8 8 2 2 2 2 8 8 8 8 8 8 8 8 8 8 8 8 8 1 Table 2: List of 487 features extracted by our framework. No. of features † We consider three types of network: retweet, mention, and hashtag co-occurrence networks. The hashtag co-occurrence network is undirected. * Distribution types. For each distribution, the following eight statistics are computed and used as individual features: min, max, median, mean, std. deviation, skewness, kurtosis, and entropy. ** Part-of-Speech (POS) tag. There are eight POS tags: verbs, nuns, adjectives, modal auxiliaries, pre- determiners, interjections, adverbs, and pronouns. *** For each feature we compute mean and std. deviation. diffusion patterns, content and language, sentiment, timing, and user meta-data. The classes and types of features are reported in Table 2 and discussed next. All of the feature time series in this study are available in our public dataset. 2.2.1 Network and diffusion features Twitter actively fosters interconnectivity. Users are linked by means of follower/followee relations. Content travels from person to person via retweets. Tweets themselves can be addressed to specific users via mentions. The network structure carries crucial information 7 for the characterization of different types of communication. In fact, the usage of network features significantly helps in tasks like astroturf detection [64]. Our system reconstructs three types of networks: retweet, mention, and hashtag co-occurrence networks. Retweet and mention networks have users as nodes, with a directed link between a pair of users that follows the direction of information spreading - toward the user retweeting or being mentioned. Hashtag co-occurrence networks have undirected links between hashtag nodes when two hashtags have occurred together in a tweet. All networks are weighted according to the number of interactions and co-occurrences. For each network, a set of features is computed, including in- and out-strength (weighted degree) distribution, density, shortest- path distribution, and so on. (cf. Table 2). 2.2.2 User-based features User meta-data is crucial to classify communication patterns in social media [55, 30]. We extract user-based features from the details provided by the Twitter API about the author of each tweet and the originator of each retweet. Such features include the distribution of follower and followee numbers, and the number of tweets produced by the users (cf. Table 2). 2.2.3 Timing features The temporal dimension associated with the production and consumption of content may reveal important information about campaigns and their evolution [35]. The most basic time-related feature we considered is the number of tweets produced in a given time interval. Other timing features describe the distributions of the intervals between two consecutive events, like two tweets or retweets (cf. Table 2). 2.2.4 Content and language features Many recent papers have demonstrated the importance of content and language features in revealing the nature of social media conversations [24, 52, 57, 12, 48]. For example, de- ceiving messages generally exhibit informal language and short sentences [13]. Our system extracts language features by applying a Part-of-Speech (POS) tagging technique, which identifies different types of natural language components, or POS tags. The following POS tags are extracted: verbs, nouns, adjectives, modal auxiliaries, pre-determiners, interjec- tions, adverbs, pronouns, and wh-pronouns.2 Tweets can be therefore analyzed to study how such POS tags are distributed. Other content features include the length and entropy of the tweet content (cf. Table 2). 2www.comp.leeds.ac.uk/ccalas/tagsets/upenn.html 8 2.2.5 Sentiment features Sentiment analysis is a powerful tool to describe the attitude or mood of an online con- versation. Sentiment extracted from social media conversations has been used to forecast offline events, including elections and financial market fluctuations [71, 10], and is known to affect information spreading [56, 33]. Our framework leverages several sentiment extraction techniques to generate various sentiment features, including happiness score [42], arousal, valence and dominance scores [77], polarization and strength [82], and emotion score [1] (cf. Table 2). 2.3 Feature selection Our system generates a set I of I = 487 features (cf. Table 2) designed to extract signals from a collection of tweets and distinguish promoted trends from organic ones. Some features are more predictive than others; some are by definition correlated with each other due to temporal dependencies. Most of the correlations are related to the volume of data. For instance the two most correlated features immediately prior to the trending point are the size of the hashtag cooccurrence network and the size of its largest connected component (Pearson's ρ = 0.75). This is why it is important to perform feature selection to eliminate redundant features and identify a combination of features that yield good classification performance. There are several methods to select the most predictive features in a classification task [36]. We implemented a simple greedy forward feature selection method, summarized as follows: (i) initialize the set of selected features S = ∅; (ii) for each feature i ∈ I − S, consider the union set U = S ∪{i}; (iii) train the classifier using the features in U ; (iv) test the average performance of the classifier trained on this set; (v) add to S the feature that provides the best performance; (vi) repeat (ii)–(v). We terminate the feature selection procedure if the AUC (cf. Sec. 2.5) increases by less than 0.05 between two consecutive steps. Most of the experiments terminate after selecting fewer than 10 features. The time series for the selected features are passed as input to the learning algorithms. In the next subsections we provide details about our experimental setting and learning models. 2.4 Experimental setting Our experimental setting follows a pipeline of feature selection, model building, and perfor- mance evaluation. We apply the wrapper approach to select features and evaluate perfor- mance iteratively [40]. During each iteration (Fig. 4), we train and evaluate models using candidate subsets of features and expand the set of selected features using the greedy ap- proach described in Sec. 2.3. Once we identify the set of features that performs best, we report results of experiments using only this set of features. In each experiment and for each feature, an algorithm receives in input a time series with L = 35 data points to carry out its detection. The length of the time series and its 9 delay D with respect to the trending point are discussed in Sec. 3; different experiments will consider different delays. A set of feature time series is used to either train a learning model or evaluate its accuracy. The learning algorithms are discussed in the next subsection. For evaluation, we compute a Receiver Operating Characteristic (ROC) curve, which plots the true positive rate (TPR) versus the false positive rate (FPR) at various thresholds. Accuracy is evaluated by measuring the Area Under the ROC Curve (AUC) [28] with 10-fold cross validation, and averaging AUC scores across the folds. A random-guess classifier produces the diagonal line where TPR equals FPR, corresponding to a 50% AUC score. Classifiers with higher AUC scores perform better and the perfect classifier in this setting achieves a 100% AUC score. We adopt AUC to measure accuracy because it is not biased by the imbalance in our classes (75 promoted trends versus 852 organic ones, as discussed earlier). 2.5 Learning algorithms Let us describe the learning systems for online campaign detection based on multidimen- sional time-series data from social media. We identified an algorithm, called K-Nearest Neighbor with Dynamic Time Warping (KNN-DTW), that is capable of dealing with mul- tidimensional time series classification. For evaluation purposes, we compare the classifica- tion results against two baselines: SAX-VSM and KNN. These three methods are described next. 2.5.1 KNN-DTW classifier KNN-DTW is a state-of-the-art algorithm to classify multidimensional time series, illus- trated in Fig. 4. During learning, we provide our model with training and testing sets generated by 10-fold cross validation. Time series for each feature are processed in paral- lel using dynamic time warping (DTW), which measures the similarity between two time series after finding an optimal match between them by "warping" the time axis [7]. This allows the method to absorb some non-linear variations in the time series, for example different speed or resolution of the data. For efficiency, we initially apply a time series coarsening strategy called piece-wise aggregation. We split each original time series into p equally long sections and replace the time-series values by the section averages, reducing the dimensionality from L to L(cid:48) = L/p. k,L(cid:48)}. For trend i and feature k, we thus obtain a coarsened time series f i Then, DTW computes the distance between all pairs of points of two given trend time series k and f j f i k,t(cid:48))2. Points closer to each other are more likely to be matched. To create a mapping between the two time series, an optimal path is computed over the time-series distance matrix. A path must start from the beginning of each time series and terminate at its end. The path between first and last points is then computed by minimizing the cumulative distance (γ) k . Each element of the resulting L(cid:48)×L(cid:48) distance matrix is M ij k,1, f i k = {f i k (t, t(cid:48)) = (f i k,2,··· , f i k,t−f j 10 Figure 4: Wrapper method description for KNN-DTW. We present the pipeline of our complete system, including feature selection and model evaluation steps. Input data feed into the system for training (green arrow) and testing (blue arrow) steps. over alternative paths. This problem can be solved via dynamic programming [7] using the following recurrence: γ(t, t(cid:48)) = M (t, t(cid:48)) + min{γ(t − 1, t(cid:48) − 1), γ(t − 1, t(cid:48)), γ(t, t(cid:48) − 1)} (indices i, j, k dropped for readability). The distance γij k is used as the ij-th element of the N × N trend similarity matrix Γk. The computation of similarity between time series using DTW requires O(L(cid:48)2) opera- tions. Some heuristic strategies use lower-bounding techniques to reduce the computational complexity [41]. Another technique is to re-sample the data before adopting DTW. Our coarsening approach reduces the computational costs by a factor of p2. We achieved a sig- nificant increase in efficiency with marginal classification accuracy deterioration by setting p = 5 (L(cid:48) = 7). In the evaluation step, we use the K-Nearest Neighbor (KNN) algorithm [23] to assign a class score to a test trend q. We compare q with each training trend i to obtain a DTW distance γiq k for each feature k. We then find the K = 5 labeled trends with smallest DTW 11 distance from q, and compute the fraction of promoted trends sq k among these nearest neighbors. We finally average across features to obtain the class score ¯sq. Higher values of ¯sq indicate a high probability that q is a promoted trend. Class scores, together with ground-truth labels, allow us to computate the AUC of a model, which is then averaged across folds according to cross validation. 2.5.2 SAX-VSM classifier Our first baseline, called SAX-VSM, blends symbolic dimensionality reduction and vector space models [66]. Time series are encoded via Symbolic Aggregate approXimation (SAX), yielding a compact symbolic representation that has been used for time series anomaly and motif detection, time series clustering, indexing, and more [49, 50]. A symbolic represen- tation encodes numerical features as words. A vector space model is then applied to treat time series as documents for classification purposes, similarly to what is done in informa- tion retrieval. In our implementation, we first apply piece-wise aggregation and then use SAX to represent the data points in input as a single word of L(cid:48) letters from an alphabet ℵ. This choice and the parameters ℵ = 5 and L(cid:48) = 4 are based on prior optimization [66], and variations to these settings only marginally affect performance. Each time-series value is mapped into a letter by dividing the range of the feature values into ℵ regions in such a way as to obtain equiprobable intervals under an assumption of normality [50]. In the training phase, for each feature, we build two sets of words corresponding to organic and promoted trends, respectively. In the test phase, a new instance is assigned to the class with the majority of word matches across features. In case of a tie we assign a random class. For further details about this baseline and its implementation, we refer the reader to the SAX-VSM project website.3 2.5.3 K-Nearest Neighbors classifier Our second baseline is an off-the-shelf implementation of the traditional K-Nearest Neigh- bors algorithm [23] for time-series classification. We used the Python scikit-learn pack- age [61]. We selected KNN because it can capture and learn time-series patterns without requiring any pre-processing of the raw time-series data. We created the feature vectors for each trend by concatenating into a single vector the continuous-valued time series rep- resenting each feature. The nearest neighbor classifier computes the Euclidean distance between pairs of single-vector time series. For a test trend, the class score is given by the fraction of promoted trends among the K = 5 nearest neighbors. 3github.com/jMotif/sax-vsm_classic 12 3 Results In this section, we present results of experiments design to evaluate the ability of our machine learning framework to discriminate between organic and promoted trends. For all experiments, each feature time series consists of 120 real-valued data points equally divided before and after the trending point. Although in principle we could use the entire time series for classification, ex-post information would not serve our goal of early detection of social media campaigns in a streaming scenario that resembles a real setting, where information about the future evolution of a trend is obviously unavailable. For this reason, we consider only a subset consisting of L data points ending with delay D since the trending point; D ≤ 0 data points for early detection, D > 0 for classification after trending. We evaluate the performance of our detection framework as a function of the delay parameter D. The case D = 0 involves detection immediately at trending time. However, we also consider D < 0 to examine the performance of our algorithms based on data preceding the trending point; of course the detection would not occur until D = 0, when one would become aware of the trending hashtag. Time series are encoded using the settings described above (L = 35 windows of length (cid:96) = 6 hours sliding every δ = 20 minutes). 3.1 Method comparison We carried out an extensive benchmark of several configurations of our system for campaign detection. The performance of the algorithms as a function of varying delays D is plotted in Fig. 5. In addition, we introduce random temporal shifts for each trend time series to test the robustness of the algorithms. In real-world scenarios, one would ideally expect to detect a promoted trend without knowing the trending point. To simulate such scenarios, we designed an experiment that introduces variations that randomly shift each time series around its trending point. The temporal shifts are sampled from gaussian distributions with different variances. We present the results of this experiment in Fig. 6. KNN-DTW and KNN display the best detection accuracy (measured by AUC) in gen- eral. Their performance is comparable (Fig. 5). The AUC score is on average around 95% for detecting promoted trends after trending. In the early detection task, we observe scores above 70%. This is quite remarkable given the small amount of data available before the trending point. KNN-DTW also displays a strong robustness to temporal shifts, pointing to the advantage of time warping (Fig. 6). The KNN algorithm is less robust because it computes point-wise similarities between time series without any temporal alignment; as the variance of the temporal shifts increases, we observe a significant drop in accuracy. SAX-VSM benefits from the time series encoding and provides good detection performance (on average around 80% AUC) but early detection accuracy is poor, close to random for D < 0. A strong feature of SAX-VSM is its robustness to temporal shifts, similar to KNN-DTW. 13 Figure 5: Methods comparison. Classification performance of different learning algorithms on encoded and raw time series. The AUC is measured for various delays D. Confidence intervals represent standard errors based on 10-fold cross validation. Our experiments suggest that temporal encoding is a crucial ingredient for successful classification of time-series data. Encoding reduces the dimensionality of the signal. More importantly, encoding preserves (most) information about temporal trends and makes an algorithm robust to random shifts, which is an importance advantage in real-world sce- narios. SAX-VSM ignores long-term temporal ordering. KNN-DTW, on the other hand, computes similarities using a time series representation that preserves the long-term tem- poral order, even as time warping may alter short-term trends. This turns out to be a crucial advantage to achieve both high accuracy and robustness. Using AUC as an evaluation metric has the advantage of not requiring discretization of scores into binary class labels. However, detection of promoted trends in real scenar- ios requires binary classification by a threshold. In this way we can measure accuracy, precision, recall, and identify misclassified accounts. Fig. 7 illustrates the distribution of probabilistic scores produced by the KNN-DTW classifier as a function of the delay for the two classes of trends, organic and promoted. The scores are computed for leave-out test instances, across folds. An ideal classifier would separate these distributions completely, achieving perfect accuracy. Test instances in the intersection between two distributions either are misclassified or have low-confidence scores. Examples of misclassified instances are discussed in Sec. 3.3. For D < 0, KNN-DTW generates more conservative scores, and the separation between the organic and promoted class distributions is smaller. For D > 0, 14 Figure 6: Temporal robustness. AUC of different learning algorithms with random tem- poral shifts versus the standard deviation of the shifts. We repeated the experiment for various delay values D. Significance levels of differences in consecutive experiments are marked as (*) p < 0.05 and (**) p < 0.01. KNN-DTW scores separate the two classes well. To convert continuos scores into binary labels, we calculated the threshold values that maximize the F1 score of each experiment; this score combines precision and recall. Trends with scores above the threshold are la- beled as promoted. The best accuracy and F1 score are obtained shortly after trending, at D = 20. 3.2 Feature analysis Let us explore the roles and importance of different features for trend detection. To this end, we identify the significant features using the greedy selection algorithm described in Sec. 2.3, and group them by the five classes (user meta-data, content, network, sentiment, and timing) previously defined. We focus on KNN-DTW, our best performing method. After selecting the top 10 features for different delays D, we compute the fractions of top features in each class, as illustrated by Fig. 8. We list the top features for experiments D = 0 (early detection) and D = 40 (classification) in Table 3. The usefulness of content features does not appear to change significantly between early 15 Figure 7: Distributions of KNN-DTW classifier scores. We use Kernel Density Estimation (KDE), a non-parametric smoothing method, to estimate the probability densities based on finite data samples. We also show the threshold values that separate the two classes yielding an optimal F1 score. and late detection. In the early detection task, user features seem to contribute significantly more than any other class, possibly because early adopters reveal strong signals about the nature of trends. As we move past the trending point, signals from early adopters are flooded by increasing numbers of participants. Timing and network features become increasingly important as the involvement of more users allows to analyze group activity and network structure patterns. 16 Figure 8: KNN-DTW feature analysis. Stacked plot showing how different feature classes are represented among the top 10 selected features. Table 3: Top 10 features for experiments with different values of D. Delay Features 40 0 Classes Timing Number of tweets Content Max. proportion of pronouns in a tweet Network Entropy of hashtag cooccurrence network degree Timing Entropy of time between two consecutive mentions Timing Mean time between two consecutive tweets Sentiment Entropy of emoticon scores Timing Median time between two consecutive tweets User Max. originator's followers count Kurtosis of mention network degree distribution Network Entropy of pre-determiner POS frequency in a tweet Content Max. hashtag cooccurrence network degree Network User Entropy of number of originator's friends count User Max. originator's statuses count Median time between two consecutive tweets Timing Skewness of time between two consecutive mentions Timing Median of sender's lists count Min. originator's lists count Median of mention network out-degree Min. frequency of adjective POS in a tweet Mean frequency of noun POS in a tweet User User Network Content Content 17 3.3 Analysis of misclassifications In Fig. 9, we illustrate We conclude our analysis by discussing when our system fails. how some key features of misclassified trends diverge from the majority of the trends that are correctly classified. We observe that some misclassified trends follow the temporal characteristics of the other class. This is best illustrated in the case of volume (number of tweets). An advantage of continuous class scores is that we can tune the classification threshold to achieve a desired balance between precision and recall, or between false positives and false negatives. False negative errors are the most costly for a detection system: a promoted trend mistakenly labeled as organic would easily go unchecked among the larger number of correctly labeled organic trends. Focusing our attention on a few specific instances of false negatives generated by our system, we gained some insight on the reasons triggering the mistakes. First of all, it is conceivable that promoted trends are sustained by organic activity before promotion and therefore they are essentially indistinguishable from organic ones until the promotion triggers the trending behavior. It is also reasonable to expect a decline in performance for long delays: as more users join the conversation, promoted trends become harder to distinguish from organic ones. This may explain the dip in accuracy observed for the longest delay (cf. Fig. 5). False positives (organic trends mistakenly labeled as promoted) can be manually filtered out in post-processing and are therefore less costly. However, analysis of false positives provides for some insight as well. Some trends in our dataset, such as #watchsuitstonight and #madmen, were promoted via alternative communication channels (television and radio), rather than via Twitter. This has become a common practice in recent years, as more and more Twitter campaigns are mentioned or advertised externally to trigger organic-looking responses in the audience. Our system recognized such instances as promoted, whereas their ground-truth labels did not. Those campaigns were therefore wrongly counted as false positives, penalizing our algorithms in the evaluation. We find it remarkable that in these cases our system is capable of learning the signature of promoted trends, even though the promotion occurs outside of the social media itself. 4 Related work Recent work on social media provides a better understanding of human communication dynamics such as collective attention and information diffusion [78], the emergence of trends [47, 31], social influence and political mobilization [11, 21, 22, 75]. Different information diffusion mechanisms may determine the trending dynamics of hashtags and other memes on social media. Exogenous and endogenous dynamics produce memes with distinctive characteristics [68, 59, 45, 31, 33]: external events occurring in the real world (e.g., a natural disaster or a terrorist attack) can generate chatter on the platform and therefore trigger the trending of a new, unforeseen hashtag; other topics (e.g., politics 18 Figure 9: Comparison between feature time series of misclassified and correctly clas- sified trends. Time series of the top five features (columns) for promoted (top) and organic (bottom) trends in the D = 40 detection task. The black lines and gray areas represent the average and 95% confidence intervals of time series for correctly classified trends. Time series of misclassified trends are shown in red. Misclassified organic trends (false positives) are: #bobsantigoldlive, #evildead, #galaxyfamily, #gethappy, #stingray, #thewalkingdead, #timeto365, #watchsuitstonight, and #whyiwatchsuits. Mis- classified promoted trends (false negatives) are: #1dmemories, #20singersthatilike, #8thseed, #bnppo13, #ciaa, #expowest, #jaibrooksforpresident, #justintimberweek, #kobalt400, #mentionsomeonecuteandbeautiful, #nyc, #realestate, #stars, #sxsw, #wbc, and #wcw. #makeboringbrilliant, #madmen, #nyias, #oneboston, or entertainment) are continuously discussed and sometimes a particular conversation can accrue lots of attention and generate trending memes. The promotional campaigns studied here can be seen as a type of exogenous factor affecting the visibility of memes. The present work, to the best of our knowledge, is the first to investigate the early detec- tion of promoted content on social media. We focus our attention on advertisement, which can play an important role in information campaigns. Trending memes are considered an indicator of collective attention in social media [83, 45], and as such they have been used to predict real-world events, like the winner of a popular reality TV show [19]. Although emerging from collective attention, communication on social media can be manipulated, for example for political gain, as in the case of astroturf [54, 64]. Recent work analyzes emerging topics, memes, and conversations triggered by real world events [2, 5, 14]. Studies of information dissemination reveal mechanisms governing 19 content production and consumption [17] as well as prediction of future content popularity. Cheng et al. study the prediction of photo-sharing cascade size [15] and recurrence [16] on Facebook. Machine learning models can predict future popularity of emerging hashtags and content on social media [70, 51]. Features extracted from content [39], sentiment [33, 43], community structure [80, 81], and temporal signatures [62, 34, 76] are commonly used to train such models. In this paper we leverage similar features, but for the novel task of campaign detection. Furthermore, our task is more challenging because we deal with dynamic features whose changes over time are captured in high-dimensional time series. Another topic related to our research is rumor detection. Rumors may emerge or- ganically as genuine conversation and spread out of control. They are characterized and sustained by ambiguous contexts, where correctness and completeness of information or the meaning of a situation is not obviously apparent [27]. Examples are situations of crisis or topics of public debate [53]. Existing systems to identify rumors are based mostly on content analysis [63, 44] and clustering techniques [29, 38]. An open question is to de- termine if rumor detection might benefit from the wide set of feature classes we propose here. The proposed framework is based on a mixture of features common in social media data, including emotional and sentiment information. The literature has reported extensively on the use of social media content to describe emotional and demographic characteristics of users [55, 33, 56]. The use of language in online communities is the focus of two recent papers [24, 52]: the authors observe that the language of social media users evolves, and common patterns emerge over time. The language style of users adapts to achieve better fitness in the conversation [25]. These findings suggest that language contains strong signals, in particular if studied in conjunction with other dimensions of the data. Our study confirms the importance of content for campaign detection. Finally, our system builds on network features and diffusion patterns of social media messages. Network structure and information diffusion in social media have been studied extensively [3, 46]. Network features are highly predictive of certain types of social media abuse, like astroturf, that attempt to simulate grassroots online conversations [64, 65, 69, 30, 74]. Such artificial campaigns produce peculiar patterns of information diffusion: the topology of retweet or mention networks is often a stronger signal than content or language. The present findings are consistent with this body of work, as network features are helpful in detecting promoted content after trending. 5 Conclusions As we increasingly rely on social media to satisfy our information needs, it is important to recognize the dynamics behind online campaigns. In this paper, we posed the problem of early-detection of promoted trends on social media, discussed the challenges that this problem presents, and proposed a supervised computational framework to attack it. The 20 proposed system leverages time series representing the evolution of different features char- acterizing trending campaigns. The list includes features relative to network structure and diffusion patterns, sentiment, language and content features, timing, and user meta-data. We demonstrated the crucial advantages of encoding temporal sequences. We achieved good accuracy in campaign detection. Our early detection performance is remarkable when one considers the challenging nature of the problem and the low volume of data available in the early stage of a campaign. We also studied the robustness of the proposed algorithms by introducing random temporal shifts around the trending point, simulating realistic scenarios in which the trending point can only be estimated with limited accuracy. One of the advantages of our framework is that of providing interpretable feature classes. We explored how content, network, and user features affect detection performance. Exten- sive feature analysis revealed that signatures of campaigns can be detected early, especially by leveraging content and user features. After the trending point, network and temporal features become more useful. The availability of data about organic and promoted trends is subject to Twitter's recipe for selecting trending hashtags. There is no certain way to know if and when social media platforms make any changes to such recipes. However, nothing in our approach assumes any knowledge of a particular platform's trending recipe. If the recipe changes, our system could be retrained accordingly. This work represents an important step toward the automatic detection of campaigns. The problem is of paramount importance, since social media shape the opinions of millions of users in everyday life. Further work is needed to study whether different classes of campaigns (say, legitimate advertising vs. terrorist propaganda) may exhibit characteristics captured by distinct features. Many of the features leveraged in our model, such as those related to network structure and temporal attributes, capture activity patterns that could provide useful signals to detect astroturf [64]. Therefore, our framework could in principle be applied to astroturf detection, if longitudinal training data about astroturf campaigns were available. Acknowledgements We thank Mohsen JafariAsbagh, Qiaozhu Mei, Zhe Zhao, and Sergey Malinchik for helpful discussions in 2012 and 2013. We are also grateful to two anonymous reviewers, whose suggestions greatly improved this paper. This work was supported by ONR (N15A-020- 0053), NSF (grant CCF-1101743), DARPA (grant W911NF-12-1-0037), and the McDonnell Foundation. The funders had no role in study design, data collection and analysis, decision to publish, or preparation of the manuscript. 21 References [1] Apoorv Agarwal, Boyi Xie, Ilia Vovsha, Owen Rambow, and Rebecca Passonneau. Sentiment analysis of Twitter data. In Proceedings of the Workshop on Languages in Social Media, pages 30–38. ACL, 2011. [2] Charu C Aggarwal and Karthik Subbian. Event detection in social streams. In SDM, volume 12, pages 624–635. SIAM, 2012. [3] Lars Backstrom, Dan Huttenlocher, Jon Kleinberg, and Xiangyang Lan. Group for- In Proc. of mation in large social networks: membership, growth, and evolution. the 12th ACM SIGKDD international conference on Knowledge discovery and data mining, pages 44–54, 2006. [4] Eytan Bakshy, Jake M Hofman, Winter A Mason, and Duncan J Watts. Everyone's an influencer: quantifying influence on Twitter. In Proc. of the 4th ACM international conference on Web search and data mining, pages 65–74, 2011. [5] Hila Becker, Mor Naaman, and Luis Gravano. Beyond trending topics: Real-world event identification on twitter. ICWSM, 11:438–441, 2011. [6] J Berger and Jonathan Morgan. The isis twitter census: Defining and describing the population of isis supporters on twitter. The Brookings Project on US Relations with the Islamic World, 3:20, 2015. [7] Donald J Berndt and James Clifford. Using dynamic time warping to find patterns in time series. In Proc. of AAAI Workshop on Knowledge Discovery in Databases, pages 359–370. Seattle, WA, 1994. [8] Alessandro Bessi, Mauro Coletto, George Alexandru Davidescu, Antonio Scala, Guido Caldarelli, and Walter Quattrociocchi. Science vs conspiracy: Collective narratives in the age of misinformation. PLoS ONE, 10(2):e0118093, 02 2015. [9] Alessandro Bessi and Emilio Ferrara. Social bots distort the 2016 us presidential election online discussion. First Monday, 21(11), 2016. [10] Johan Bollen, Huina Mao, and Xiaojun Zeng. Twitter mood predicts the stock market. Journal of Computational Science, 2(1):1–8, 2011. [11] Robert M Bond, Christopher J Fariss, Jason J Jones, Adam DI Kramer, Cameron Marlow, Jaime E Settle, and James H Fowler. A 61-million-person experiment in social influence and political mobilization. Nature, 489(7415):295–298, 2012. [12] Federico Botta, Helen Susannah Moat, and Tobias Preis. Quantifying crowd size with mobile phone and twitter data. Royal Society open science, 2(5):150162, 2015. 22 [13] E Briscoe, S Appling, and H Hayes. Cues to deception in social media communications. In Proceedings of the Hawaii International Conference on System Sciences, 2014. [14] Mario Cataldi, Luigi Di Caro, and Claudio Schifanella. Emerging topic detection on twitter based on temporal and social terms evaluation. In Proceedings of the Tenth International Workshop on Multimedia Data Mining, page 4. ACM, 2010. [15] Justin Cheng, Lada Adamic, P Alex Dow, Jon Michael Kleinberg, and Jure Leskovec. Can cascades be predicted? In Proceedings of the 23rd international conference on World wide web, pages 925–936. ACM, 2014. [16] Justin Cheng, Lada A Adamic, Jon M Kleinberg, and Jure Leskovec. Do cascades recur? In Proceedings of the 25th International Conference on World Wide Web, pages 671–681. International World Wide Web Conferences Steering Committee, 2016. [17] Giovanni Luca Ciampaglia, Alessandro Flammini, and Filippo Menczer. The produc- tion of information in the attention economy. Scientific Reports, 5:9452, 2015. [18] Giovanni Luca Ciampaglia, Prashant Shiralkar, Luis M. Rocha, Johan Bollen, Filippo Menczer, and Alessandro Flammini. Computational fact checking from knowledge networks. PLoS ONE, 10(6):e0128193, 06 2015. [19] Fabio Ciulla, Delia Mocanu, Andrea Baronchelli, Bruno Gon¸calves, Nicola Perra, and Alessandro Vespignani. Beating the news using social media: the case study of Amer- ican Idol. EPJ Data Science, 1(1):1–11, 2012. [20] Eric M Clark, Chris A Jones, Jake Ryland Williams, Allison N Kurti, Michell Craig Nortotsky, Christopher M Danforth, and Peter Sheridan Dodds. Vaporous marketing: Uncovering pervasive electronic cigarette advertisements on twitter. arXiv preprint arXiv:1508.01843, 2015. [21] Michael D Conover, Clayton Davis, Emilio Ferrara, Karissa McKelvey, Filippo Menczer, and Alessandro Flammini. The geospatial characteristics of a social move- ment communication network. PloS ONE, 8:e55957, 2013. [22] Michael D Conover, Emilio Ferrara, Filippo Menczer, and Alessandro Flammini. The digital evolution of Occupy Wall Street. PloS ONE, 8:e64679, 2013. [23] Thomas M Cover and Peter E Hart. Nearest neighbor pattern classification. Infor- mation Theory, IEEE Transactions on, 13(1):21–27, 1967. [24] Cristian Danescu-Niculescu-Mizil, Robert West, Dan Jurafsky, Jure Leskovec, and Christopher Potts. No country for old members: user lifecycle and linguistic change in online communities. In Proceedings of the 22nd international conference on World Wide Web, pages 307–318, 2013. 23 [25] Abhimanyu Das, Sreenivas Gollapudi, Emre Kıcıman, and Onur Varol. Information dissemination in heterogeneous-intent networks. In Proceedings of the 8th ACM Con- ference on Web Science, pages 259–268. ACM, 2016. [26] Clayton Allen Davis, Onur Varol, Emilio Ferrara, Alessandro Flammini, and Filippo Menczer. Botornot: A system to evaluate social bots. In Proceedings of the 25th In- ternational Conference Companion on World Wide Web, pages 273–274. International World Wide Web Conferences Steering Committee, 2016. [27] Nicholas DiFonzo and Prashant Bordia. Rumor, gossip and urban legends. Diogenes, 54(1):19–35, 2007. [28] Tom Fawcett. An introduction to ROC analysis. Pattern recognition letters, 27(8):861– 874, 2006. [29] Emilio Ferrara, Mohsen JafariAsbagh, Onur Varol, Vaheda Qazvinian, Filippo Menczer, and Alessandro Flammini. Clustering memes in social media. In Proceed- ings of the 2013 IEEE/ACM International Conference on Advances in Social Networks Analysis and Mining, pages 548–555. IEEE/ACM, 2013. [30] Emilio Ferrara, Onur Varol, Clayton Davis, Filippo Menczer, and Alessandro Flam- mini. The rise of social bots. Communications of the ACM, 59(7):96–104, 2016. [31] Emilio Ferrara, Onur Varol, Filippo Menczer, and Alessandro Flammini. Traveling trends: social butterflies or frequent fliers? In Proc. of the first ACM conference on Online social networks, pages 213–222, 2013. [32] Emilio Ferrara, Wen-Qiang Wang, Onur Varol, Alessandro Flammini, and Aram Gal- styan. Predicting online extremism, content adopters, and interaction reciprocity. In International Conference on Social Informatics, pages 22–39. Springer, 2016. [33] Emilio Ferrara and Zeyao Yang. Quantifying the effect of sentiment on information diffusion in social media. PeerJ Computer Science, 1:e26, 2015. [34] Flavio Figueiredo, Fabr´ıcio Benevenuto, and Jussara M Almeida. The tube over time: characterizing popularity growth of youtube videos. In Proceedings of the fourth ACM international conference on Web search and data mining, pages 745–754. ACM, 2011. [35] Rumi Ghosh, Tawan Surachawala, and Kristina Lerman. Entropy-based classification of retweeting activity on twitter. In Proceedings of KDD workshop on Social Network Analysis (SNA-KDD), August 2011. [36] Isabelle Guyon and Andr´e Elisseeff. An introduction to variable and feature selection. The Journal of Machine Learning Research, 3:1157–1182, 2003. 24 [37] Stefanie Haustein, Timothy D Bowman, Kim Holmberg, Andrew Tsou, Cassidy R Sugimoto, and Vincent Larivi`ere. Tweets as impact indicators: Examining the im- plications of automated "bot" accounts on twitter. Journal of the Association for Information Science and Technology, 67(1):232–238, 2016. [38] Mohsen JafariAsbagh, Emilio Ferrara, Onur Varol, Filippo Menczer, and Alessandro Flammini. Clustering memes in social media streams. Social Network Analysis and Mining, 4(1):1–13, 2014. [39] Salman Jamali and Huzefa Rangwala. Digging digg: Comment mining, popularity In Web Information Systems and Mining, prediction, and social network analysis. 2009. WISM 2009. International Conference on, pages 32–38. IEEE, 2009. [40] George H John, Ron Kohavi, Karl Pfleger, et al. Irrelevant features and the subset In Machine learning: proceedings of the eleventh international selection problem. conference, pages 121–129, 1994. [41] Eamonn Keogh and Chotirat Ann Ratanamahatana. Exact indexing of dynamic time warping. Knowledge and information systems, 7(3):358–386, 2005. [42] Isabel M Kloumann, Christopher M Danforth, Kameron Decker Harris, Catherine A Bliss, and Peter Sheridan Dodds. Positivity of the english language. PloS one, 7(1):e29484, 2012. [43] Jonas Krauss, Stefan Nann, Daniel Simon, Peter A Gloor, and Kai Fischbach. Predict- ing movie success and academy awards through sentiment and social network analysis. In ECIS, pages 2026–2037, 2008. [44] Sejeong Kwon, Meeyoung Cha, Kyomin Jung, Wei Chen, and Yajun Wang. Prominent features of rumor propagation in online social media. In Proc. IEEE International Conference on Data Mining series (ICDM), 2013. [45] Janette Lehmann, Bruno Gon¸calves, Jos´e J Ramasco, and Ciro Cattuto. Dynamical classes of collective attention in Twitter. In Proc. the 21th International Conference on World Wide Web, pages 251–260, 2012. [46] Kristina Lerman and Rumi Ghosh. Information contagion: An empirical study of the spread of news on Digg and Twitter social networks. In Proceedings of the 4th International AAAI Conference on Weblogs and Social Media, pages 90–97, 2010. [47] Jure Leskovec, Lars Backstrom, and Jon Kleinberg. Meme-tracking and the dynamics of the news cycle. In Proceedings of the 15th ACM SIGKDD International Conference on Knowledge Discovery and Data Mining, pages 497–506. ACM, 2009. 25 [48] Adrian Letchford, Helen Susannah Moat, and Tobias Preis. The advantage of short paper titles. Royal Society Open Science, 2(8):150266, 2015. [49] Jessica Lin, Eamonn Keogh, Stefano Lonardi, and Bill Chiu. A symbolic representation of time series, with implications for streaming algorithms. In Proceedings of the 8th ACM SIGMOD workshop on Research issues in data mining and knowledge discovery, pages 2–11, 2003. [50] Jessica Lin, Eamonn Keogh, Li Wei, and Stefano Lonardi. Experiencing sax: a novel symbolic representation of time series. Data Mining and Knowledge Discov- ery, 15(2):107–144, 2007. [51] Zongyang Ma, Aixin Sun, and Gao Cong. On predicting the popularity of newly emerging hashtags in twitter. Journal of the American Society for Information Science and Technology, 64(7):1399–1410, 2013. [52] Julian John McAuley and Jure Leskovec. From amateurs to connoisseurs: modeling In Proceedings of the 22nd the evolution of user expertise through online reviews. international conference on World Wide Web, pages 897–908. ACM, 2013. [53] Marcelo Mendoza, Barbara Poblete, and Carlos Castillo. Twitter under crisis: Can we trust what we RT? In Proceedings of the first workshop on social media analytics, pages 71–79. ACM, 2010. [54] Panagiotis T Metaxas and Eni Mustafaraj. Social media and the elections. Science, 338(6106):472–473, 2012. [55] Alan Mislove, Sune Lehmann, Yong-Yeol Ahn, Jukka-Pekka Onnela, and J Niels In Proceedings of Rosenquist. Understanding the demographics of Twitter users. the 5th International AAAI Conference on Weblogs and Social Media, 2011. [56] Lewis Mitchell, Kameron Decker Harris, Morgan R Frank, Peter Sheridan Dodds, and Christopher M Danforth. The geography of happiness: Connecting Twitter senti- ment and expression, demographics, and objective characteristics of place. PloS one, 8(5):e64417, 2013. [57] Delia Mocanu, Andrea Baronchelli, Nicola Perra, Bruno Gon¸calves, Qian Zhang, and Alessandro Vespignani. The Twitter of Babel: Mapping world languages through microblogging platforms. PloS one, 8(4):e61981, January 2013. [58] Seth A Myers and Jure Leskovec. The bursty dynamics of the twitter information In Proceedings of the 23rd international conference on World wide web, network. pages 913–924. ACM, 2014. 26 [59] Seth A Myers, Chenguang Zhu, and Jure Leskovec. Information diffusion and exter- In Proceedings of the 18th ACM SIGKDD international nal influence in networks. conference on Knowledge discovery and data mining, pages 33–41. ACM, 2012. [60] Alexandra Olteanu, Onur Varol, and Emre Kıcıman. Distilling the outcomes of per- sonal experiences: A propensity-scored analysis of social media. In Proc. of The 20th ACM Conference on Computer-Supported Cooperative Work and Social Computing, 2017. [61] F. Pedregosa, G. Varoquaux, A. Gramfort, V. Michel, B. Thirion, O. Grisel, M. Blon- del, P. Prettenhofer, R. Weiss, V. Dubourg, J. Vanderplas, A. Passos, D. Cournapeau, M. Brucher, M. Perrot, and E. Duchesnay. Scikit-learn: Machine learning in Python. Journal of Machine Learning Research, 12:2825–2830, 2011. [62] Henrique Pinto, Jussara M Almeida, and Marcos A Gon¸calves. Using early view patterns to predict the popularity of youtube videos. In Proceedings of the sixth ACM international conference on Web search and data mining, pages 365–374. ACM, 2013. [63] Vahed Qazvinian, Emily Rosengren, Dragomir R Radev, and Qiaozhu Mei. Rumor has it: Identifying misinformation in microblogs. In Proceedings of the Conference on Empirical Methods in Natural Language Processing, pages 1589–1599. ACL, 2011. [64] J. Ratkiewicz, M. Conover, M. Meiss, B. Goncalves, A. Flammini, and F. Menczer. Detecting and tracking political abuse in social media. In Proceedings of the 5th International AAAI Conference on Weblogs and Social Media, pages 297–304, 2011. [65] J. Ratkiewicz, M. Conover, M. Meiss, B. Gon¸calves, S. Patil, A. Flammini, and F. Menczer. Truthy: mapping the spread of astroturf in microblog streams. In Pro- ceedings of the 20th International Conference on World Wide Web, pages 249–252, 2011. [66] Pavel Senin and Sergey Malinchik. Sax-vsm: Interpretable time series classification using sax and vector space model. In Data Mining (ICDM), 2013 IEEE 13th Inter- national Conference on, pages 1175–1180. IEEE, 2013. [67] Maeve Shearlaw. From britain to beijing: how governments manipulate the in- ternet. Accessed online at http://www.theguardian.com/world/2015/apr/02/russia- troll-factory-kremlin-cyber-army-comparisons, April 2015. [68] Didier Sornette, Fabrice Deschatres, Thomas Gilbert, and Yann Ageon. Endogenous versus exogenous shocks in complex networks: An empirical test using book sale rankings. Physical Review Letters, 93(22):228701, 2004. 27 [69] VS Subrahmanian, Amos Azaria, Skylar Durst, Vadim Kagan, Aram Galstyan, Kristina Lerman, Linhong Zhu, Emilio Ferrara, Alessandro Flammini, Filippo Menczer, Andrew Stevens, Alexander Dekhtyar, Shuyang Gao, Tad Hogg, Farshad Kooti, Yan Liu, Onur Varol, Prashant Shiralkar, Vinod Vydiswaran, Qiaozhu Mei, and Tim Hwang. The DARPA Twitter Bot Challenge. IEEE Computer, 49(6):38–46, 2016. Preprint arXiv:1601.05140. [70] Oren Tsur and Ari Rappoport. What's in a hashtag?: content based prediction of the spread of ideas in microblogging communities. In Proceedings of the fifth ACM international conference on Web search and data mining, pages 643–652. ACM, 2012. [71] Andranik Tumasjan, Timm Oliver Sprenger, Philipp G Sandner, and Isabell M Welpe. Predicting elections with twitter: What 140 characters reveal about political senti- ment. ICWSM, 10:178–185, 2010. [72] Twitter Faqs about on twitter. https://support.twitter.com/articles/101125, July 2016. trends Inc. Accessed online at [73] U.S. Securities and Exchange Commission. Updated investor alert: Social media and investing - stock rumors. Accessed online at http://www.sec.gov/oiea/investor- alerts-bulletins/ia rumors.html, November 2015. [74] Onur Varol, Emilio Ferrara, Clayton A Davis, Filippo Menczer, and Alessandro Flam- mini. Online human-bot interactions: Detection, estimation, and characterization. In Proc. International Conference on Web and Social Media. AAAI, 2017. arXiv preprint arXiv:1703.03107. [75] Onur Varol, Emilio Ferrara, Christine L Ogan, Filippo Menczer, and Alessandro Flam- mini. Evolution of online user behavior during a social upheaval. In Proceedings of the 2014 ACM conference on Web science, pages 81–90. ACM, 2014. [76] Senzhang Wang, Zhao Yan, Xia Hu, Philip S Yu, and Zhoujun Li. Burst time predic- tion in cascades. In Proceedings of the Twenty-Ninth AAAI Conference on Artificial Intelligence, pages 325–331. AAAI Press, 2015. [77] Amy Beth Warriner, Victor Kuperman, and Marc Brysbaert. Norms of valence, arousal, and dominance for 13,915 english lemmas. Behavior research methods, pages 1–17, 2013. [78] L Weng, A Flammini, A Vespignani, and F Menczer. Competition among memes in a world with limited attention. Scientific Reports, 2, 2012. [79] L Weng, F Menczer, and YY Ahn. Virality prediction and community structure in social networks. Scientific reports, 3:2522–2522, 2012. 28 [80] Lilian Weng, Filippo Menczer, and Yong-Yeol Ahn. Virality prediction and community structure in social networks. Scientific reports, 3, 2013. [81] Lilian Weng, Jacob Ratkiewicz, Nicola Perra, Bruno Gon¸calves, Carlos Castillo, Francesco Bonchi, Rossano Schifanella, Filippo Menczer, and Alessandro Flammini. The role of information diffusion in the evolution of social networks. In Proceedings of the 19th ACM SIGKDD international conference on Knowledge discovery and data mining, pages 356–364. ACM, 2013. [82] Theresa Wilson, Janyce Wiebe, and Paul Hoffmann. Recognizing contextual polar- In Proceedings of the conference on Human ity in phrase-level sentiment analysis. Language Technology and Empirical Methods in Natural Language Processing, pages 347–354. ACL, 2005. [83] Fang Wu and Bernardo A Huberman. Novelty and collective attention. Proceedings of the National Academy of Sciences, 104:17599–17601, 2007. [84] Jaewon Yang and Jure Leskovec. Patterns of temporal variation in online media. In Proceedings of the fourth ACM international conference on Web search and data mining, pages 177–186. ACM, 2011. [85] Zhe Zhao, Paul Resnick, and Qiaozhu Mei. Enquiring minds: Early detection of rumors in social media from enquiry posts. In Proceedings of the 24th International Conference on World Wide Web, pages 1395–1405. International World Wide Web Conferences Steering Committee, 2015. 29
1801.09288
2
1801
2019-03-04T15:11:28
Disinformation Warfare: Understanding State-Sponsored Trolls on Twitter and Their Influence on the Web
[ "cs.SI" ]
Over the past couple of years, anecdotal evidence has emerged linking coordinated campaigns by state-sponsored actors with efforts to manipulate public opinion on the Web, often around major political events, through dedicated accounts, or "trolls." Although they are often involved in spreading disinformation on social media, there is little understanding of how these trolls operate, what type of content they disseminate, and most importantly their influence on the information ecosystem. In this paper, we shed light on these questions by analyzing 27K tweets posted by 1K Twitter users identified as having ties with Russia's Internet Research Agency and thus likely state-sponsored trolls. We compare their behavior to a random set of Twitter users, finding interesting differences in terms of the content they disseminate, the evolution of their account, as well as their general behavior and use of Twitter. Then, using Hawkes Processes, we quantify the influence that trolls had on the dissemination of news on social platforms like Twitter, Reddit, and 4chan. Overall, our findings indicate that Russian trolls managed to stay active for long periods of time and to reach a substantial number of Twitter users with their tweets. When looking at their ability of spreading news content and making it viral, however, we find that their effect on social platforms was minor, with the significant exception of news published by the Russian state-sponsored news outlet RT (Russia Today).
cs.SI
cs
Disinformation Warfare: Understanding State-Sponsored Trolls on Twitter and Their Influence on the Web∗ Savvas Zannettou1, Tristan Caulfield2, Emiliano De Cristofaro2, Michael Sirivianos1, Gianluca Stringhini3, Jeremy Blackburn4 1Cyprus University of Technology, 2University College London, 3Boston University, 4University of Alabama at Birmingham [email protected], {t.caulfield,e.decristofaro}@ucl.ac.uk, [email protected], [email protected], [email protected] 9 1 0 2 r a M 4 ] I S . s c [ 2 v 8 8 2 9 0 . 1 0 8 1 : v i X r a Abstract Over the past couple of years, anecdotal evidence has emerged linking coordinated campaigns by state-sponsored actors with efforts to manipulate public opinion on the Web, often around major political events, through dedicated accounts, or "trolls." Although they are often involved in spreading disinformation on social media, there is little understanding of how these trolls operate, what type of content they disseminate, and most im- portantly their influence on the information ecosystem. In this paper, we shed light on these questions by analyz- ing 27K tweets posted by 1K Twitter users identified as hav- ing ties with Russia's Internet Research Agency and thus likely state-sponsored trolls. We compare their behavior to a random set of Twitter users, finding interesting differences in terms of the content they disseminate, the evolution of their account, as well as their general behavior and use of Twitter. Then, using Hawkes Processes, we quantify the influence that trolls had on the dissemination of news on social platforms like Twitter, Red- dit, and 4chan. Overall, our findings indicate that Russian trolls managed to stay active for long periods of time and to reach a substantial number of Twitter users with their tweets. When looking at their ability of spreading news content and making it viral, however, we find that their effect on social platforms was minor, with the significant exception of news published by the Russian state-sponsored news outlet RT (Russia Today). Introduction 1 Recent political events and elections have been increasingly ac- companied by reports of disinformation campaigns attributed to state-sponsored actors [8]. In particular, "troll farms," al- legedly employed by Russian state agencies, have been actively commenting and posting content on social media to further the Kremlin's political agenda [27]. In late 2017, the US Congress started an investigation on Russian interference in the 2016 US Presidential Election, releasing the IDs of 2.7K Twitter ac- counts identified as Russian trolls. Despite the growing relevance of state-sponsored disinfor- mation, the activity of accounts linked to such efforts has not been thoroughly studied. Previous work has mostly looked at campaigns run by bots [8, 11, 23]; however, automated content diffusion is only a part of the issue, and in fact recent research has shown that human actors are actually key in spreading false information on Twitter [25]. Overall, many aspects of state- sponsored disinformation remain unclear, e.g., how do state- sponsored trolls operate? What kind of content do they dissem- inate? And, perhaps more importantly, is it possible to quantify the influence they have on the overall information ecosystem on the Web? In this paper, we aim to address these questions, by relying on the set of 2.7K accounts released by the US Congress as ground truth for Russian state-sponsored trolls. From a dataset containing all tweets released by the 1% Twitter Streaming API, we search and retrieve 27K tweets posted by 1K Russian trolls between January 2016 and September 2017. We characterize their activity by comparing to a random sample of Twitter users. Then, we quantify the influence of these trolls on the greater Web, looking at occurrences of URLs posted by them on Twit- ter, 4chan [12], and Reddit, which we choose since they are impactful actors of the information ecosystem [34]. Finally, we use Hawkes Processes [18] to model the influence of each Web community (i.e., Russian trolls on Twitter, overall Twitter, Red- dit, and 4chan) on each other. Main findings. Our study leads to several key observations: 1. Trolls actually bear very small influence in making news go viral on Twitter and other social platforms alike. A noteworthy exception are links to news originating from RT (Russia Today), a state-funded news outlet: indeed, Russian trolls are quite effective in "pushing" these URLs on Twitter and other social networks. 2. The main topics discussed by Russian trolls target very specific world events (e.g., Charlottesville protests) and organizations (such as ISIS), and political threads related to Donald Trump and Hillary Clinton. ∗A preliminary version of this paper appears in the 4th Workshop on The Fourth Workshop on Computational Methods in Online Misbehavior (Cyber- Safety 2019) -- WWW'19 Companion Proceedings. This is the full version. 3. Trolls adopt different identities over time, i.e., they "reset" their profile by deleting their previous tweets and changing their screen name/information. 1 4. Trolls exhibit significantly different behaviors compared to other (random) Twitter accounts. For instance, the lo- cations they report concentrate in a few countries like the USA, Germany, and Russia, perhaps in an attempt to ap- pear "local" and more effectively manipulate opinions of users from those countries. Also, while random Twitter users mainly tweet from mobile versions of the platform, the majority of the Russian trolls do so via the Web Client. 2 Background In this section, we provide a brief overview of the social net- works studied in this paper, i.e., Twitter, Reddit, and 4chan, which we choose because they are impactful actors on the Web's information ecosystem [34]. Twitter. Twitter is a mainstream social network, where users can broadcast short messages, called "tweets," to their follow- ers. Tweets may contain hashtags, which enable the easy index and search of messages, as well as mentions, which refer to other users on Twitter. Reddit. Reddit is a news aggregator with several social fea- tures. It allows users to post URLs along with a title; posts can get up- and down- votes, which dictate the popularity and or- der in which they appear on the platform. Reddit is divided to "subreddits," which are forums created by users that focus on a particular topic (e.g., /r/The Donald is about discussions around Donald Trump). 4chan. 4chan is an imageboard forum, organized in communi- ties called "boards," each with a different topic of interest. A user can create a new post by uploading an image with or with- out some text; others can reply below with or without images. 4chan is an anonymous community, and several of its boards are reportedly responsible for a substantial amount of hateful content [12]. In this work we focus on the Politically Incor- rect board (/pol/) mainly because it is the main board for the discussion of politics and world events. Furthermore, 4chan is ephemeral, i.e., there is a limited number of active threads and all threads are permanently deleted after a week. 3 Datasets Russian trolls. We start from the 2.7K Twitter accounts sus- pended by Twitter because of connections to Russia's Internet Research Agency. The list of these accounts was released by the US Congress as part of their investigation of the alleged Russian interference in the 2016 US presidential election, and includes both Twitter's user ID (which is a numeric unique identifier as- sociated to the account) and the screen name.1 From a dataset storing all tweets released by the 1% Twitter Streaming API, we search for tweets posted between January 2016 and Septem- ber 2017 by the user IDs of the trolls. Overall, we obtain 27K tweets from 1K out of the 2.7K Russian trolls. Note that the criteria used by Twitter to identify these troll accounts are not public. What we do know is that this is not the complete set of 1See https://democrats-intelligence.house.gov/uploadedfiles/exhibit b.pdf (a) Hour of Day (b) Hour of Week Figure 1: Temporal characteristics of tweets from Russian trolls and random Twitter users. active Russian trolls, because 6 days prior to this writing Twitter announced they have discovered over 1K more troll accounts.2 Nonetheless, it constitutes an invaluable "ground truth" dataset enabling efforts to shed light on the behavior of state-sponsored troll accounts. Baseline dataset. We also compile a list of random Twitter users, while ensuring that the distribution of the average num- ber of tweets per day posted by the random users is similar to the one by trolls. To calculate the average number of tweets posted by an account, we find the first tweet posted after Jan- uary 1, 2016 and retrieve the overall tweet count. This number is then divided by the number of days since account creation. Having selected a set of 1K random users, we then collect all their tweets between January 2016 and September 2017, obtain- ing a total of 96K tweets. We follow this approach as it gives a good approximation of posting behavior, even though it might not be perfect, since (1) Twitter accounts can become more or less active over time, and (2) our datasets are based on the 1% Streaming API, thus, we are unable to control the number of tweets we obtain for each account. 4 Analysis In this section, we present an in-depth analysis of the activities and the behavior of Russian trolls. First, we provide a general characterization of the accounts and a geographical analysis of the locations they report. Then, we analyze the content they share and how they evolved until their suspension by Twitter. Finally, we present a case study of one specific account. 4.1 General Characterization Temporal analysis. We observe that Russian trolls are continu- ously active on Twitter between January, 2016 and September, 2017, with a peak of activity just before the second US pres- idential debate (October 9, 2016). Fig. 1(a) shows that most tweets from the trolls are posted between 14:00 and 15:00 UTC. In Fig. 1(b), we also report temporal characteristics based on hour of the week, finding that both datasets follow a diurnal pattern, while trolls' activity peaks around 14:00 and 15:00 UTC on Mondays and Wednesdays. Considering that Moscow is three hours ahead UTC, this distribution does not rule out that tweets might actually be posted from Russia. 2https://blog.twitter.com/official/en us/topics/company/2018/2016-election- update.html 2 0510152034567% of tweetsRussian TrollsBaseline204060801001201401600.40.60.81.01.21.41.61.8% of tweetsRussian TrollsBaseline Figure 2: Number of Russian troll accounts created per day. Screen Name Description (%) Word bigram (%) (%) 4-gram (%) Word Word 10.7% follow me 7.8% 1.3% news 1.5% news news 10.7% breaking news 2.6% 1.5% follow 1.2% line bote 8.1% news aus 2.1% 1.3% conservative 1.1% blac online 7.8% uns in 2.1% 1.3% trump 0.8% bote daily 6.2% deiner stdt 2.1% 1.1% und today 0.6% rist 5.9% die news 2.1% 1.1% maga ezekiel2517 0.6% nlin 5.8% wichtige und 2.1% maria 0.5% onli 1.0% love 5.3% nachrichten aus 2.1% 1.0% us 0.5% lack black 1.0% die 0.4% bert voice 2.1% 5.0% aus deiner 4.3% die dn 2.1% 1.0% nachrichten martin 0.4% poli Table 1: Top 10 words found in Russian troll screen names and ac- count descriptions. We also report character 4-grams for the screen names and word bigrams for the description. Account creation. Next, we examine the dates when the trolls infiltrated Twitter, by looking at the account creation dates. From Fig. 2, we observe that 71% of them are actually created before 2016. There are some interesting peaks, during 2016 and 2017: for instance, 24 accounts are created on July 12, 2016, ap- prox. a week before the Republican National Convention (when Donald Trump received the nomination), while 28 appear on August 8, 2017, a few days before the infamous Unite the Right rally in Charlottesville. Taken together, this might be evidence of coordinated activities aimed at manipulating users' opinions with respect to specific events. Account characteristics. We also shed light on the troll ac- count profile information. In Table 1, we report the top ten words appearing in the screen names and the descriptions of Russian trolls, as well as character 4-grams for screen names and word bigrams for profile descriptions. Interestingly, a sub- stantial number of Russian trolls pose as news outlets, evident from the use of the term "news" in both the screen name (1.3%) and the description (10.7%). Also, it seems they attempt to in- crease the number of their followers, thus their reach of Twit- ter users, by nudging users to follow them (see, e.g., "follow me" appearing in almost 8% of the accounts). Finally, 10.3% of the Russian trolls describe themselves as Trump support- ers: "trump" and "maga" (Make America Great Again, one of Trump campaign's main slogans). Language. Looking at the language (as provided via the Twitter API) of the tweets posted by Russian trolls, we find that most of them (61%) are in English, although a substantial portion are in Russian (27%), and to a lesser extent in German (3.5%). In Fig. 3(a), we plot the cumulative distribution function (CDF) 3 (a) (b) Figure 3: CDF of number of (a) languages used (b) clients used per user. Client (Trolls) Twitter Web Client twitterfeed Twibble.io IFTTT TweetDeck NovaPress dlvr.it Twitter for iPhone Zapier.com Twitter for Android (%) Client (Baseline) 50.1% TweetDeck 13.4% Twitter for iPhone 9.0% Twitter for Android 8.6% Twitter Web Client 8.3% GrabInbox 4.6% Twitter for iPad 2.3% IFTTT 0.8% twittbot.net 0.6% Twitter for BlackBerry 0.6% Mobile Web (M2) (%) 32.6% 26.2% 22.6% 6.1% 2.0% 1.4% 1.0% 0.9% 0.6% 0.4% Table 2: Top 10 Twitter clients (as % of tweets). of the number of different languages for each user: 64% of the Russian trolls post all their tweets in only one language, com- pared to only 54% for random users. Overall, by comparing the two distributions, we observe that random Twitter users tend to use more languages in their tweets compared to the trolls. Client. Finally, we analyze the clients used to post tweets. We do so since previous work [6] shows that the client used by of- ficial or professional accounts are quite different that the ones used by regular users. Table 2 reports the top 10 clients for both Russian trolls and baseline users. We find the latter prefer to use Twitter clients for mobile devices (48%) and the Tweet- Deck dashboard (32%), whereas, the former mainly use the Web client (50%). We also assess how many different clients Russian trolls use throughout our dataset: in Fig. 3(b), we plot the CDF of the number of clients used per user. We find that 65% of the Russian trolls use only one client, 28% of them two different clients, and the rest more than three, which is overall less than the random baseline users. 4.2 Geographical Analysis Location. We then study users' location, relying on the self- reported location field in their profiles. Note that users not only may leave it empty, but also change it any time they like, so we look at locations for each tweet. We retrieve it for 75% of the tweets by Russian trolls, gathering 261 different entries, which we convert to a physical location using the Google Maps Geocoding API. In the end, we obtain 178 unique locations for the trolls, as depicted in Fig. 4 (red circles). The size of the circles on the map indicates the number of tweets that ap- pear at each location. We do the same for the baseline, getting 2,037 different entries, converted by the API to 894 unique lo- cations. We observe that most of the tweets from Russian trolls 01/0909/0905/1001/1109/1105/1201/1309/1305/1401/1509/1505/1601/1709/170510152025# of accounts created0510152025# of languages0.00.20.40.60.81.0CDFRussian TrollsBaseline246810# of clients per user0.00.20.40.60.81.0CDFRussian TrollsBaseline Figure 4: Distribution of reported locations for tweets by Russian trolls (red circles) and baseline (green triangles). (a) (b) Figure 5: CDF of the number of (a) characters and (b) words in each tweet. come from locations within the USA and Russia, and some from European countries, like Germany, Belgium, and Italy. On the other hand, tweets in our baseline are more uniformly distributed across the globe, with many tweets from North and South America, Europe, and Asia. This suggests that Russian trolls may be pretending to be from certain countries, e.g., USA or Germany, aiming to pose as locals and better manipulate opinions. This explanation becomes more plausible when we consider that a plurality of trolls' tweets have their location set as a generic form of "US," as opposed to a specific city, state, or even region. Interestingly, the 2nd, 3rd, and 4th most popu- lar location for trolls to tweet from are Moscow, St. Petersburg, and a generic form of "Russia." We also assess whether users change their country of origin based on the self-reported loca- tion: only a negligible percentage (1%) of trolls change their country, while for the baseline the percentage is 16%. Timezone. We then study the timezone chosen by the users in their account setting. In Table 3, we report the top 10 time- zones for each dataset, in terms of the corresponding tweet vol- umes. Two thirds of the tweets by trolls appear to be from US timezones, while a substantial percentage (18%) from Russian ones. Whereas, the baseline has a more diverse set of timezones, which seems to mirror findings from our location analysis. We also check whether users change their timezone set- tings, finding that 7% of the Russian trolls do so two to three times. The most popular changes are Berlin to Bern (18 times), Nairobi to Moscow (10), and Nairobi to Volgograd (10).By con- Timezone (Trolls) Eastern Time Pacific Time Volgograd Central Time Moscow Bern Minsk Yerevan Nairobi Baku (%) Timezone (Baseline) 38.87% Athens 18.37% Pacific Time 10.03% London 9.43% Tokyo 8.18% Central Time 2.56% Eastern Time 2.06% Seoul 1.96% Brasilia 1.52% Buenos Aires 1.29% Urumqi (%) 24.41% 21.41% 21.27% 3.83% 3.75% 2.10% 1.97% 1.97% 1.92% 1.50% Table 3: Top 10 timezones (as % of tweets). Trolls Baseline (%) Hashtag (%) Hashtag 0.7% iHeartAwards 1.8% UrbanAttires 0.6% BestFanArmy 1.6% Vacature 0.6% Harmonizers 1.0% mPlusPlaces 0.5% iOSApp 0.5% JouwBaan 0.5% vacature 0.4% KCA (%) Hashtag 7.2% US 2.6% tcot 2.1% PJNET 1.4% entertainment 1.3% top 1.2% topNews 0.8% ISIS 0.8% Merkelmussbleiben 0.4% Psychic 0.7% IslamKills Hashtag (%) news 0.6% politics 0.6% sports 0.6% business 0.5% 0.9% job money 0.5% 0.9% Directioners world 0.9% JIMIN 0.5% MAGA 0.9% PRODUCE101 0.5% health 0.8% VoteMainFPP 0.5% local 0.4% 0.8% Werk BlackLivesMatter 0.7% breaking 0.4% Table 4: Top 20 hashtags in tweets from Russian trolls and baseline users. 0.4% RT 0.4% Libertad2016 0.6% dts trast, this almost never happens for baseline accounts. 4.3 Content Analysis Text. Next, we quantify the number of characters and words contained in each tweet, and plot the corresponding CDF in Fig. 5, finding that Russian trolls tend to post longer tweets. Media. We then assess whether Russian trolls use images and videos in a different way than random baseline users. For Rus- sian trolls (resp., baseline accounts), 66% (resp., 73%) of the tweets include no images, 32% (resp., 18%) exactly one im- age, and 2% (resp., 9%) more than one. This suggests that Rus- sian trolls disseminate a considerable amount of information via single-image tweets. As for videos, only 1.5% of the tweets from Russian trolls includes a video, as opposed to 6.4% for baseline accounts. 4 020406080100120140# of characters in tweet0.00.20.40.60.81.0CDFRussian TrollsBaseline0510152025303540# of words in tweet0.00.20.40.60.81.0CDFRussian TrollsBaseline Trolls (%) Mention 2.1% postsovet 0.8% DLGreez Baseline (%) Mention 0.3% RasSpotlights 0.2% GenderReveals 0.2% TattedChanel 0.2% gemvius 0.2% DrizzyNYC 0.2% August Alsina 0.2% RihannaBITCH 0.2% sexualfeed (%) 0.1% 0.1% 0.1% 0.1% 0.1% 0.1% 0.1% 0.1% 0.1% 0.2% IGGYAZALEAoO 0.1% Domain (Trolls) twitter.com reportsecret.com riafan.ru politexpert.net youtube.com vk.com instagram.com yandex.ru infreactor.org cbslocal.com livejournal nevnov.ru ksnt.com kron4.com viid.me newinform.com inforeactor.ru rt.com washigntonpost.com seattletimes.com (%) Domain (Baseline) 12.81% twitter.com 7.02% youtube.com 3.42% vine.co 2.10% factissues.com 1.88% blogspot.com.cy 1.58% instagram.com 1.53% facebook.com 1.50% worldstarr.info 1.36% trendytopic.info 1.35% minibird.jp 1.35% yaadlinksradio.com 1.07% soundcloud.com 1.01% linklist.me 0.93% twimg.com 0.93% appparse.com 0.89% cargobayy.net 0.84% virralclub.com 0.81% tistory.com 0.75% twitcasting.tv 0.73% nytimes.com (%) 35.51% 4.21% 3.94% 3.24% 1.92% 1.90% 1.68% 1.47% 1.39% 1.25% 1.24% 1.24% 1.15% 1.09% 1.08% 0.88% 0.84% 0.50% 0.49% 0.48% Table 6: Top 20 domains included in tweets from Russian trolls and baselines users. (%) Mention 0.4% TasbihIstighfar 0.4% raspotlights Mention leprasorium zubovnik realDonaldTrump 0.6% DanaGeezus 0.4% FunnyBrawls midnight blicqer gloed up wylsacom TalibKweli zvezdanews GiselleEvns 0.6% ruopentwit 0.6% Spoontamer 0.6% YouTube 0.5% ChrixMorgan 0.3% UrbanAttires 0.4% sergeylazarev 0.3% BTS twt 0.4% RT com 0.4% kozheed 0.3% YouTube 0.3% Harry Styles 0.3% shortdancevids 0.3% KylieJenner NYC 0.2% PetsEvery30 0.3% BaddiessNation Table 5: Top 20 mentions in tweets from trolls and baseline. Hashtags. Our next step is to study the use of hashtags in tweets. Russian trolls use at least one hashtag in 32% of their tweets, compared to 10% for the baseline. Overall, we find 4.3K and 7.1K unique hashtags for trolls and random users, respec- tively, with 74% and 78% of them only appearing once. In Ta- ble 4, we report the top 20 hashtags for both datasets. Trolls appear to use hashtags to disseminate news (7.2%) and politics (2.6%) related content, but also use several that might be indica- tors of propaganda and/or controversial topics, e.g., #ISIS, #Is- lamKills, and #BlackLivesMatter. For instance, we find some notable examples including: "We just have to close the bor- ders, 'refugees' are simple terrorists #IslamKills" on March 22, 2016, "#SyrianRefugees ARE TERRORISTS from #ISIS #Is- lamKills" on March 22, 2016, and "WATCH: Here is a typi- cal #BlackLivesMatter protester: 'I hope I kill all white babes!' #BatonRouge <url>" on July 17, 2016. We also study when these hashtags are used by the trolls, finding that most of them are well distributed over time. How- ever, there are some interesting exceptions, e.g., with #Merkel- mussbleiben (a hashtag seemingly supporting Angela Merkel) and #IslamKills. Specifically, tweets with the former appear ex- clusively on July 21, 2016, while the latter on March 22, 2016, when a terrorist attack took place at Brussels airport. These two examples illustrate how the trolls may be coordinating to push specific narratives on Twitter. Mentions. We find that 46% of trolls' tweets include mentions to 8.5K unique Twitter users. This percentage is much higher for the random baseline users (80%, to 41K users). Table 5 re- ports the 20 top mentions we find in tweets from Russian trolls and baseline users. We find several Russian accounts, like 'lep- rasorium' (a popular Russian account that mainly posts memes) in 2% of the mentions, as well as popular politicians like 'real- DonaldTrump' (0.6%). The practice of mentioning politicians on Twitter may reflect an underlying strategy to mutate users' opinions regarding a particular political topic, which has been also studied in previous work [3]. URLs. We then analyze the URLs included in the tweets. First of all, we note that 53% of the trolls' tweets include at least a URL, compared to only 27% for the random baseline. There is an extensive presence of URL shorteners for both datasets, e.g., bit.ly (12% for trolls and 26% for the baseline) and ift.tt (10% for trolls and 2% for the baseline), therefore, in Novem- ber 2017, we visit each URL to obtain the final URL after all redirections. In Fig. 6, we plot the CDF of the number of URLs per unique domain. We observe that Russian trolls dis- seminate more URLs in their tweets compared to the baseline. Figure 6: CDF of number of URLs per domain. This might indicate that Russian trolls include URLs to increase their credibility and positive user perception; indeed, [10] show that adding a URL in a tweet correlates with higher credibil- ity scores. Also, in Table 6, we report the top 20 domains for both Russian trolls and the baseline. Most URLs point to con- tent within Twitter itself; 13% and 35%, respectively. Links to a number of popular social networks like YouTube (1.8% and 4.2%, respectively) and Instagram (1.5% and 1.9%) appear in both datasets. We also note that among the top 20 domains, there are also a number of news outlets linked from trolls' tweets, e.g., Washington Post (0.7%), Seattle Times (0.7%), and state-sponsored news outlets like RT (0.8%) in trolls' tweets, but much less so from the baseline. Sentiment analysis. Next, we assess the sentiment and sub- jectivity of each tweet for both datasets using the Pattern li- brary [24]. Fig. 7(a) plots the CDF of the sentiment scores of tweets posted by Russian trolls and our baseline users. We ob- serve that 30% of the tweets from Russian trolls have a pos- itive sentiment, and 18% negative. These scores are not too distant from those of random users where 36% are positive and 16% negative, however, Russian trolls exhibit a unique be- havior in terms of sentiment, as a two-sample Kolmogorov- Smirnov test unveils significant differences between the dis- tributions (p < 0.01). Overall, we observe that Russian trolls 5 100101102103# of URLs per domain0.00.20.40.60.81.0CDFRussian TrollsBaseline In Fig. 8(a), we plot the CDF of the number of followers per tweet measured at the time of that tweet. On average, Russian trolls have 7K followers and 3K friends, while our baseline has 25K followers and 6K friends. We also note that in both sam- ples, tweets reached a large number of Twitter users; at least 1K followers, with peaks up to 145K followers. These results high- light that Russian trolls have a non-negligible number of fol- lowers, which can assist in pushing specific narratives to a much greater number of Twitter users. We also assess the evolution of the Russian trolls in terms of the number of their followers and friends. To this end, we get the follower and friend count for each user on their first and last tweet and calculate the differ- ence. Fig. 8(b) plots the CDF of the increase/decrease of the fol- lowers and friends for each troll as well as random user in our baseline. We observe that, on average, Russian trolls increase their number of followers and friends by 2,065 and 1,225, re- spectively, whereas for the baseline we observe an increase of 425 and 133 for followers and friends, respectively. This sug- gests that Russian trolls work hard to increase their reachability within Twitter. Tweet Deletion. Arguably, a reasonable strategy to avoid de- tection after posting tweets that aim to manipulate other users might be to delete them. This is particularly useful when troll accounts change their identity and need to modify the narra- tive that they use to influence public opinion. With each tweet, the Streaming API returns the total number of available tweets a user has up to that time. Retrieving this count allows us to observe if a user has deleted a tweet, and around what period; we call this an "observed deletion." Recall that our dataset is based on the 1% sample of Twitter, thus, we can only estimate, in a conservative way, how many tweets are deleted; specifi- cally, in between subsequent tweets, a user may have deleted and posted tweets that we do not observe. In Fig. 9, we plot the CDF of the number of deleted tweets per observed dele- tion. We observe that 13% of the Russian trolls delete some of their tweets, with a median percentage of tweet deletion equal to 9.7%. Whereas, for the baseline set, 27% of the accounts delete at least one tweet, but the median percentage is 0.1%. This means that the trolls delete their tweets in batches, possi- bly trying to cover their tracks or get a clean slate, while random users make a larger number of deletions but only a small per- centage of their overall tweets, possibly because of typos. We also report the distribution, over each month, of tweet deletions in Fig. 10. Specifically, we report the mean of the percentages for all observed deletions in our datasets. Most of the tweets from Russian trolls are deleted in October 2016, suggesting that these accounts attempted to get a clean slate a few months be- fore the 2016 US elections. 4.5 Case Study While the previous results provide a quantitative character- ization of Russian trolls behavior, we believe there is value showing a concrete example of the behavior exhibited and how techniques played out. We start on May 15, 2016, where the troll with screen name 'Pen Air', was posing as a news ac- count via its profile description: "National American news." On September 8, 2016 as the US presidential elections approached, (a) (b) Figure 7: CDF of sentiment and subjectivity scores for tweets of Rus- sian trolls and random users. (a) (b) Figure 8: CDF of the number of (a) followers/friends for each tweet and (b) increase in followers/friends for each user from the first to the last tweet. tend to be more negative/neutral, while our baseline is more positive. We also compare subjectivity scores (Fig. 7(b)), find- ing that tweets from trolls tend to be more subjective; again, we perform significance tests revealing differences between the two distributions (p < 0.01). LDA analysis. We also use the Latent Dirichlet Allocation (LDA) model to analyze tweets' semantics. We train an LDA model for each of the datasets and extract 10 distinct topics with 10 words, as reported in Table 7. Overall, topics from Rus- sian trolls refer to specific world events (e.g., Charlottesville) as well as specific news related to politics (e.g., North Korea and Donald Trump). By contrast, topics extracted from the random sample are more general (e.g., tweets regarding birthdays). 4.4 Account Evolution Screen name changes. Previous work [20] has shown that malicious accounts often change their screen name in order to assume different identifies. Therefore, we investigate whether trolls show a similar behavior, as they might change the narra- tive with which they are attempting to influence public opin- ion. Indeed, we find that 9% of the accounts operated by trolls change their screen name, up to 4 times during the course of our dataset. Some examples include changing screen names from "OnlineHouston" to "HoustonTopNews," or "Jesus Quintin Perez" to "WorldNewsPolitics," in a clear attempt to pose as news-related accounts. In our baseline, we find that 19% of the accounts changed their Twitter screen names, up to 11 times during our dataset; highlighting that changing screen names is a common behavior of Twitter users in general. Followers/Friends. Next, we look at the number of follow- ers and friends (i.e., the accounts one follows) of the Russian trolls, as this is an indication of the overall impact of a tweet. 6 1.000.750.500.250.000.250.500.751.00Sentiment Score0.00.20.40.60.81.0CDFRussian TrollsBaseline0.00.20.40.60.81.0Subjectivity Score0.00.20.40.60.81.0CDFRussian TrollsBaseline100101102103104105Count of followers/friends per tweet0.00.20.40.60.81.0CDFFollowersFriendsFollowers - BaselineFriends - Baseline1051041031021011000100101102103104105Increase/decrease of followers/friends0.00.20.40.60.81.0CDFFollowersFriendsFollowers - BaselineFriends - Baseline Topic Terms (Trolls) Topic Terms (Baseline) trump, black, people, really, one, enlist, truth, work, can, get trump, year, old, just, run, obama, breaking, will, news, police new, trump, just, breaking, obamacare, one, sessions, senate, politics, york 1 2 3 4 man, police, news, killed, shot, shooting, woman, dead, breaking, death 5 6 7 8 9 10 trump, media, tcot, just, pjnet, war, like, video, post, hillary sports, video, game, music, isis, charlottesville, will, new, health, amb can, don, people, want, know, see, black, get, just, like trump, clinton, politics, hillary, video, white, donald, president, house, calls news, world, money, business, new, one, says, state, 2016, peace now, trump, north, korea, people, right, will, check, just, playing 2016, july, come, https, trump, social, just, media, jabberduck, get happy, best, make, birthday, video, days, come, back, still, little know, never, get, love, just, night, one, give, time, can just, can, everyone, think, get, white, fifth, veranomtv2016, harmony, friends good, like, people, lol, don, just, look, today, said, keep summer, seconds, team, people, miss, don, will, photo, veranomtv2016, new like, twitter, https, first, can, get, music, better, wait, really dallas, right, fuck, vote, police, via, just, killed, teenchoice, aldubmainecelebration day, black, love, thank, great, new, now, matter, can, much Table 7: Terms extracted from LDA topics of tweets from Russian trolls and baseline users. 1 want, can, just, follow, now, get, see, don, love, will 2 3 4 5 6 7 8 9 10 URLs Events Russian state-sponsored Other news sources All Russian state-sponsored Other news sources All Mean λ0 Russian state-sponsored 0.0824 0.1865 0.0421 0.1447 0.0324 0.1557 Other news sources All /pol/ Reddit 13 19 168 159 482 861 42 118 3,055 2,930 9,531 1,537,612 6 47 127 19 720 1,685 Twitter Trolls 19 192 989 19 195 1,461 0.2264 0.1228 0.1544 0.0663 0.1553 0.0753 Figure 9: CDF of the number of deleted tweets per observe deletion. Figure 10: Average percentage of observed deletions per month. 'Pen Air' became a Trump supporter, changing its screen name to 'Blacks4DTrump' with a profile description of "African- Americans stand with Trump to make America Great Again!" Over the next 11 months, the account's tweet count grew from 49 to 642 while its follower count rose from 1.2K to nearly 9K. Then, around August 18, 2017, the account was seemingly re- purposed. Almost all of its previous tweets were deleted (the ac- count's tweet count dropped to 35), it gained a new screen name ('southlonestar2'), and was now posing as a "Proud American and TEXAN patriot! Stop ISLAM and PC. Don't mess with Texas" according to its profile description. When examining the accounts tweets, we see that most are clearly related to pol- itics, featuring blunt right-wing attacks and "talking points." For example, "Mr. Obama! Maybe you bring your girls and leave them in the bathroom with a grown man! #bathroom- bill #NObama <url>" on May 15, 2016, "#HiLIARy has only two faces! And I hate both! #NeverHillary #Hillaryliesmatter <url>" on May 19, 2016, and "RT @TEN GOP: WikiLeaks #DNCLeaks confirms something we all know: system is totally rigged! #NeverHillary <url>." on July 22, 2016. 4.6 Take-aways In summary, our analysis leads to the following observations. 7 Table 8: Total URLs with at least one event in Twitter, /pol/, Reddit, and Russian trolls on Twitter; total events for Russian state-sponsored news URLs, other news URLs and all the URLs; and mean background rate (λ0) for each platform. First, we find evidence that trolls were actively involved in the dissemination of content related to world news and politics, as well as propaganda content regarding various topics such as ISIS and Islam. Moreover, several Russian trolls were created or repurposed a few weeks before notable world events, includ- ing the Republican National Convention meeting or the Char- lottesville rally. We also find that the trolls deleted a substan- tial amount of tweets in batches and overall made substantial changes to their accounts during the course of their lifespan. Specifically, they changed their screen names aiming to pose as news outlets, experienced significant rises in the numbers of followers and friends, etc. Furthermore, our location analysis shows that Russian trolls might have tried to manipulate users located in the USA, Germany, and possibly in their own coun- try (i.e., Russia), by appearing to be located in those countries. Finally, the fact that these accounts were active up until their recent suspension also highlights the need to develop more ef- fective tools to detect such actors. 5 Thus far, we have analyzed the behavior of the Russian trolls on the Twitter platform, and how this differs from that of a base- line of random users. Allegedly, their main goal is to ultimately manipulate the opinion of other users and extend the cascade of disinformation they share (e.g., other users post similar con- tent) [5]. Therefore, we now set out to shed light on their im- pact, in terms of the dissemination of disinformation, on Twitter and on the greater Web. Influence Estimation To assess their influence, we look at the URLs posted by four groups of users: Russian trolls on Twitter, "normal" accounts on Twitter, Reddit users, and 4chan users (/pol/ board). For each unique URL, we fit a statistical model known as Hawkes 020406080100% of deleted tweets0.00.20.40.60.81.0CDFRussian TrollsBaseline2016-012016-022016-032016-042016-052016-062016-072016-082016-092016-102016-112016-122017-012017-022017-032017-042017-052017-062017-072017-082017-090102030405060Median % of deleted tweetsRussian TrollsBaseline (a) All URLs (a) All URLs (b) News URLs (b) News URLs Figure 11: Mean weights for (a) all URLs in our dataset and (b) news URLs categorized as Russian state-sponsored (R) and other main- stream and alternative news URLs (O). We also show the percent of increase/decrease between the two categories. Note that * and ** refer to statistical significance with, resp., p < 0.05 and p < 0.01. Figure 12: Estimated mean percentages of events created because of other events for (a) all URLs and (b) Russian state-sponsored URLs (R) and other mainstream and alternative news URLs (O). We also show the difference between the two categories of news. Processes [18, 19], which allows us to estimate the strength of connections between each of these four groups in terms of how likely an event -- the URL being posted by either trolls or normal users to a particular platform -- is to cause subsequent events in each of the groups. For example, a strong connection from Reddit to /pol/ would mean that a URL that appears on Reddit is likely to be seen and then re-posted on /pol/; whereas, a weak connection from trolls to normal users on Twitter indi- cates that a URL posted by trolls is less likely to be re-tweeted or re-posted by the latter. We fit the Hawkes Processes using the methodology presented by [34]. To study the dissemination of different types of content, we look at three different sets of URLs: 1) The complete set of all URLs posted by Russian trolls; 2) The subset of URLs for Russian state-sponsored news, namely, RT (Russia Today); and 3) The subset of URLs from other mainstream and alternative news sources using the list provided by [34]. Table 8 sum- marizes the number of URLs, number of events (i.e., occur- rences of a given URL) as well as the mean background rate for each category and social network. The background rate de- fines the rate at which events occur excluding the influence of the platforms included in the model; the background rate includes events created spontaneously on each platform, such as by a user sharing the article from the original source, or those generated by another platform not monitored by us like Facebook. The number of events for Russian state-sponsored news sources is substantially lower than the number of events from other news sources. This is expected since the former only includes one news source (RT), however, it is interesting that the background rates for these URLs are higher than for other news sources, meaning that events from Russian state- sponsored news are more likely to occur spontaneously. Fitting a Hawkes model yields a weight matrix, which char- acterizes the strength of the connections between the groups we study. Each weight value represents the connection strength from one group to another and can be interpreted as the ex- pected number of subsequent events that will occur on the sec- ond group after each event on the first. The mean weight val- ues over all URLs, as well as for the URLs from RT and other news URLs, are presented in Fig. 11. We observe that for /pol/, Reddit, and normal users on Twitter, the greatest weights are from each group to itself, meaning that reposts/retweets on the same site are more common than sharing the URL to the other platforms (Fig. 11(a)). For the Russian Trolls on Twitter, however, the weight is greater from the trolls to Twitter than from the trolls to themselves, perhaps reflecting their use as an avenue for disseminating information to normal Twitter users (Fig. 11(b)). Also, we observe that, in most cases, the connec- tions are stronger for non-Russia state-sponsored news, indicat- ing that regular users are more inclined to share news articles from mainstream and alternative news sources. Looking at the Russian trolls and normal Twitter users, we see that the trolls are more likely to retweet Russian state- sponsored URLs from normal Twitter users than other news sources; conversely, normal Twitter users are more likely to retweet Russian state-sponsored URLs from the troll accounts. In order to assess the significance of our results, we per- 8 /pol/RedditTwitterTrollsDestination/pol/RedditTwitterTrollsSource0.1200.1240.1250.1270.1140.1290.1670.1060.0750.2630.0830.0640.1200.1250.1160.108/pol/RedditTwitterTrollsDestination/pol/RedditTwitterTrollsR: 0.0809O: 0.1110-27.1%R: 0.1043O: 0.1205-13.4%R: 0.1286O: 0.12245.1%R: 0.1016O: 0.1328-23.5%*R: 0.1240O: 0.12241.3%R: 0.1309O: 0.1393-6.0%R: 0.1144O: 0.1969-41.9%R: 0.1040O: 0.09924.8%R: 0.0969O: 0.081518.9%R: 0.1783O: 0.2465-27.7%R: 0.1086O: 0.1252-13.2%R: 0.0848O: 0.08252.7%R: 0.1150O: 0.1157-0.6%R: 0.1668O: 0.111349.8%**R: 0.0995O: 0.1130-11.9%R: 0.0658O: 0.1144-42.5%/pol/RedditTwitter TrollsDestination/pol/RedditTwitter TrollsSource3.27%0.01%4.10%18.08%0.06%28.94%48.40%10.98%12.19%0.01%0.62%0.93%/pol/RedditTwitterTrollsDestination/pol/RedditTwitterTrollsR: 5.32%O: 9.07%-3.75R: 0.71%O: 1.17%-0.46R: 5.74%O: 8.15%-2.41R: 13.20%O: 57.15%-43.95R: 5.57%O: 12.22%-6.64R: 4.78%O: 46.78%-41.99R: 43.84%O: 51.53%-7.68R: 16.66%O: 10.49%6.17R: 24.90%O: 9.14%15.75R: 2.69%O: 0.61%2.07R: 3.13%O: 0.62%2.51R: 1.38%O: 0.72%0.66 form two-sample Kolmogorov-Smirnov tests on the weight distributions for the RT URLs and the other news URLs for each source-destination platform pair (depicted as stars in the Fig. 11(b)). Small p value means there is a statistically sig- nificant difference in the way that RT URLs propagate from the source to the destination platform. Most of the source- destination pairs have no statistical significance, however for the Russian trolls -- Twitter users pair, we find statistically sig- nificance difference with p < 0.01. In Fig. 12, we report the estimated total impact for each pair of platforms, for both Russian state-sponsored news, other news sources as well as all the observed URLs. We determine the impact by calculating, based on the estimated weights and the number of events, the percentage of events on a destina- tion platform caused by events on a source platform, following the same methodology as [34]. For all URLs (Fig. 12(a)), we find that the influence of Russian trolls is negligible on Twitter (0.01%), while for /pol/ and Reddit it is slightly higher (0.93% and 0.62%, respectively). For other pairs, the larger impacts are between Reddit -- /pol/ and Twitter-Russian trolls, mainly due to the larger population of users. Looking at the estimated impact for RT and other news sources (Fig. 12(b)), we note that the trolls influenced the other platforms approximately the same for alternative and mainstream news sources (0.72%, 0.62%, and 0.61 for /pol/, Reddit, and Twitter, respectively). Interest- ingly, Russian trolls have a much larger impact on all the other platforms for the RT news when compared to the other news sources: approximately 2 times more on /pol/, 5 times more on Reddit, and 4 times more on Twitter. Take-aways. Using Hawkes processes, we were able to assess the degree of influence Russian trolls had on Twitter, Reddit, and /pol/ by examining the diffusion of information via URLs to news. Our results indicate that their influence is actually quite limited. With the exception of news originating from the Rus- sian state-sponsored news outlet RT, the troll accounts were generally less influential than other users on Reddit, Twitter, and 4chan. However, our analysis is based only on 1K troll ac- counts found in Twitter's 1% stream, and, as mentioned previ- ously, Twitter recently announced they had discovered over 1K more trolls and more than 50K automated accounts. With that in mind, there are several potential explanations behind this lim- ited influence. For example, there might be a lot of influence attributed to regular Twitter users that belongs to newly an- nounced troll accounts. Considering that Twitter announced the discovery of "only" 1K more troll accounts, we suspect that this is not really the case. Another, more plausible explanation is that the troll accounts are just not terribly efficient at spreading news, and instead are more concerned with causing havoc by pushing ideas, engaging other users, or even taking both sides of controversial online discussions [26]. This scenario makes more sense considering that, along with 1K new troll accounts, Twitter also announced discovering over 50K automated ac- counts that might be more efficient in terms of driving traffic to specific URLs. 6 Related Work We now review previous work on opinion manipulation, po- litically motivated disinformation on the Web, and analysis of state-sponsored trolls' behavior. Opinion manipulation. The practice of swaying opinion on the Web is a long-standing issue as malicious actors attempt to push their agenda. Kumar et al. [16] study how users cre- ate multiple accounts, called sockpuppets, that participate in Web communities to manipulate users' opinions. They find that sockpuppets exhibit different posting behavior when compared to benign users. Mihaylov et al. [21] show that trolls can ma- nipulate users' opinions in forums, while in their follow-up work [22] they highlight the two types of manipulation trolls: those paid to operate and those that are called out as such by other users. Then, Volkova and Bell [30] predict the deletion of Twitter accounts because they are trolls, focusing on those that shared content related to the Russian-Ukraine crisis. Elyashar et al. [7] distinguish authentic discussions from campaigns to manipulate the public's opinion, using a set of similarity func- tions alongside historical data. Finally, Varol et al. [29] identify memes that become popular due to coordinated efforts, and achieve 0.75 AUC score before memes become trending and 0.95 afterwards. False information on the political stage. Conover et al. [3] study the interactions of right- and left-leaning communities on Twitter during the 2010 US midterm elections, finding that the retweet network has limited connectivity between the two communities, which does not happen in the mentions network; mainly because users engage others users with different ide- ologies and expose them to different opinions. Ratkiewicz et al. [23] use machine learning to detect the early stages of false political information spreading on Twitter and introduce a framework that considers topological, content-based, and crowdsourced features of the information diffusion. Wong et al. [31] quantify political leaning of users and news outlets dur- ing the 2012 US presidential election on Twitter by using an inference engine that considers tweeting and retweeting behav- ior of articles. Yang et al. [32] investigate the topics of dis- cussions on Twitter for 51 US political persons showing that Democrats and Republicans are active in a similar way on Twitter. Le et al. [17] study 50M tweets regarding the 2016 US election primaries and highlight the importance of three factors in political discussions on social media, namely the party, policy considerations, and personality of the candidates. Howard and Kollanyi [13] study the role of bots in Twitter con- versations during the 2016 Brexit referendum. By analyzing 1.5M tweets, they find that most tweets are in favor of Brexit and that there are bots with various levels of automation.Also, Hegelich and Janetzko [11] highlight that bots have a politi- cal agenda and that they exhibit various behaviors, e.g., trying to hide their identity and promoting topics through hashtags and retweets. Finally, a large body of work focuses on social bots [1, 4, 9, 8, 28] and their role in spreading disinformation, highlighting that they can manipulate the public's opinion at large scale, thus potentially affecting the outcome of political elections. 9 State-sponsored trolls. Recent work aim to uncover the behav- ior of state-sponsored trolls on the Web by analyzing ground truth datasets identified independently by social network op- erators like Facebook and Twitter. Specifically, Zannettou et al. [35] analyze a set of 10M posts by Russian and Iranian trolls on Twitter shedding light into their campaigns, their targets, and how their campaigns/targets/behavior change over time. In follow-up work, Zannettou et al. [33] focus on the dissemina- tion of images by Russian trolls on Twitter. They analyze 1.8M images finding that the dissemination of images is tightly cou- pled with real-world events and that the shared images were mainly related to politics and world news with a focus on Russia and USA. Also, Steward et al. [26] focus on discussions related to the Black Lives Matter movement and how content from Russian trolls was retweeted by other users. Using the retweet network, they find the existence of two communities; one left- and one right-leaning communities. Also, they note that trolls infiltrated both communities, setting out to push specific narra- tives. Im et al. [14] focus on detecting Twitter users that likely act on behalf of the Russian Internet Research Agency (i.e., they are Russian trolls). To do this, they use conventional ma- chine learning techniques with a set of handcrafted features. By running the proposed classifier to an out-of-sample set of users they find that Russian trolls are still very active on the Web. Kim et al [15] study the temporal traces of Russian trolls on Twitter finding cooperation between several trolls, substantial interplay between right and left leaning trolls, and that trolls have multi- ple agendas to disturb democracy in western countries. Finally, Boyd et al. [2] perform a linguistic analysis on tweets from Rus- sian trolls during the 2016 US elections: they find that trolls were targeting differently right and left leaning communities on Twitter and that their tweets were linguistically unique when compared to controlled-sample of english-speaking accounts. 7 Conclusion In this paper, we analyzed the behavior and use of the Twit- ter platform by Russian trolls during the course of 21 months. We showed that Russian trolls exhibited interesting differences when compared with a set of random users, actively dissemi- nated politics-related content, adopted multiple identities dur- ing their account's lifespan, and that they aimed to increase their impact on Twitter by increasing their followers. Also, we quantified the influence that Russian trolls have on Twitter, Reddit, and /pol/ using a statistical model known as Hawkes Processes. Our findings show that trolls' influence was not sub- stantial with respect to the other platforms, with the significant exception of news published by the Russian state-sponsored news outlet RT. Acknowledgments. This project has received funding from the European Union's Horizon 2020 Research and Innovation program under the Marie Skłodowska Curie ENCASE project (GA No. 691025) and under the Cybersecurity CONCORDIA project (GA No. 830927). References [1] A. Bessi and E. Ferrara. Social bots distort the 2016 US Presi- dential election online discussion. First Monday, 21(11), 2016. [2] R. L. Boyd, A. Spangher, A. Fourney, B. Nushi, G. Ranade, J. W. Pennebaker, and E. Horvitz. Characterizing the internet research agencys social media operations during the 2016 us presidential election using linguistic analyses. PsyArXiv. October, 1, 2018. [3] M. Conover, J. Ratkiewicz, M. R. Francisco, B. Goncalves, F. Menczer, and A. Flammini. Political Polarization on Twitter. In ICWSM, 2011. [4] C. A. Davis, O. Varol, E. Ferrara, A. Flammini, and F. Menczer. BotOrNot: A System to Evaluate Social Bots. In WWW, 2016. [5] S. Earle. Trolls, Bots and Fake News: The Mysterious World of Social Media Manipulation. https://goo.gl/nz7E8r, 2017. [6] M. Egele, G. Stringhini, C. Kruegel, and G. Vigna. Towards de- tecting compromised accounts on social networks. IEEE TDSC, 2017. [7] A. Elyashar, J. Bendahan, and R. Puzis. Is the Online Discus- sion Manipulated? Quantifying the Online Discussion Authen- ticity within Online Social Media. CoRR, abs/1708.02763, 2017. [8] E. Ferrara. Disinformation and social bot operations in the run up to the 2017 French presidential election. ArXiv 1707.00086, 2017. [9] E. Ferrara, O. Varol, C. A. Davis, F. Menczer, and A. Flammini. The rise of social bots. Commun. ACM, 2016. [10] A. Gupta and P. Kumaraguru. Credibility ranking of tweets dur- ing high impact events. In PSOSM '12, 2012. [11] S. Hegelich and D. Janetzko. Are Social Bots on Twitter Political Actors? Empirical Evidence from a Ukrainian Social Botnet. In ICWSM, 2016. [12] G. E. Hine, J. Onaolapo, E. De Cristofaro, N. Kourtellis, I. Leon- tiadis, R. Samaras, G. Stringhini, and J. Blackburn. Kek, Cucks, and God Emperor Trump: A Measurement Study of 4chan's Po- litically Incorrect Forum and Its Effects on the Web. In ICWSM, 2017. [13] P. N. Howard and B. Kollanyi. Bots, #StrongerIn, and #Brexit: Computational Propaganda during the UK-EU Referendum. Arxiv 1606.06356, 2016. [14] J. Im, E. Chandrasekharan, J. Sargent, P. Lighthammer, T. Denby, A. Bhargava, L. Hemphill, D. Jurgens, and E. Gilbert. Still out there: Modeling and Identifying Russian Troll Accounts on Twit- ter. arXiv preprint 1901.11162, 2019. [15] D. Kim, T. Graham, Z. Wan, and M.-A. Rizoiu. Tracking the Digital Traces of Russian Trolls: Distinguishing the Roles and Strategy of Trolls On Twitter. arXiv preprint 1901.05228, 2019. [16] S. Kumar, J. Cheng, J. Leskovec, and V. S. Subrahmanian. An Army of Me: Sockpuppets in Online Discussion Communities. In WWW, 2017. [17] H. T. Le, G. R. Boynton, Y. Mejova, Z. Shafiq, and P. Srinivasan. Revisiting The American Voter on Twitter. In CHI, 2017. [18] S. W. Linderman and R. P. Adams. Discovering Latent Network Structure in Point Process Data. In ICML, 2014. [19] S. W. Linderman and R. P. Adams. Scalable Bayesian Inference for Excitatory Point Process Networks. ArXiv 1507.03228, 2015. [20] E. Mariconti, J. Onaolapo, S. S. Ahmad, N. Nikiforou, M. Egele, N. Nikiforakis, and G. Stringhini. What's in a Name?: Under- standing Profile Name Reuse on Twitter. In WWW, 2017. [21] T. Mihaylov, G. Georgiev, and P. Nakov. Finding Opinion Ma- 10 nipulation Trolls in News Community Forums. In CoNLL, 2015. [22] T. Mihaylov and P. Nakov. Hunting for Troll Comments in News Community Forums. In ACL, 2016. [23] J. Ratkiewicz, M. Conover, M. R. Meiss, B. Gonalves, A. Flam- mini, and F. Menczer. Detecting and Tracking Political Abuse in Social Media. In ICWSM, 2011. [24] T. D. Smedt and W. Daelemans. Pattern for python. Journal of Machine Learning Research, 2012. [25] K. Starbird. Examining the Alternative Media Ecosystem Through the Production of Alternative Narratives of Mass Shoot- ing Events on Twitter. In ICWSM, 2017. [26] L. Steward, A. Arif, and K. Starbird. Examining Trolls and Po- larization with a Retweet Network. In MIS2, 2018. [27] The Independent. St Petersburg 'troll farm' had 90 dedicated staff working to influence US election campaign. https://ind.pn/ 2yuCQdy, 2017. [28] O. Varol, E. Ferrara, C. A. Davis, F. Menczer, and A. Flam- mini. Online Human-Bot Interactions: Detection, Estimation, and Characterization. In ICWSM, 2017. [29] O. Varol, E. Ferrara, F. Menczer, and A. Flammini. Early detec- tion of promoted campaigns on social media. EPJ Data Science, 2017. [30] S. Volkova and E. Bell. Account Deletion Prediction on RuNet: A Case Study of Suspicious Twitter Accounts Active During the Russian-Ukrainian Crisis. In NAACL-HLT, 2016. [31] F. M. F. Wong, C.-W. Tan, S. Sen, and M. Chiang. Quantifying Political Leaning from Tweets and Retweets. In ICWSM, 2013. [32] X. Yang, B.-C. Chen, M. Maity, and E. Ferrara. Social Politics: Agenda Setting and Political Communication on Social Media. In SocInfo, 2016. [33] S. Zannettou, B. Bradlyn, E. De Cristofaro, G. Stringhini, Characterizing the Use of Images by arXiv preprint and J. Blackburn. State-Sponsored Troll Accounts on Twitter. 1901.05997, 2019. [34] S. Zannettou, T. Caulfield, E. De Cristofaro, N. Kourtellis, I. Leontiadis, M. Sirivianos, G. Stringhini, and J. Blackburn. The Web Centipede: Understanding How Web Communities Influ- ence Each Other Through the Lens of Mainstream and Alterna- tive News Sources. In ACM IMC, 2017. [35] S. Zannettou, T. Caulfield, W. Setzer, M. Sirivianos, G. Stringh- ini, and J. Blackburn. Who Let the Trolls out? Towards Un- derstanding State-Sponsored Trolls. arXiv preprint 1811.03130, 2018. 11
1203.1995
1
1203
2012-03-09T05:14:20
Classify Participants in Online Communities
[ "cs.SI" ]
As online communities become increasingly popular, researchers have tried to examine participating activities in online communities as well as how to sustain online communities. However, relatively few studies have tried to understand what kinds of participants constitute online communities. In this study, we try to contribute online community research by developing "common language" to classify different participants in online communities. Specifically, we argue that the previous way to classify participants is not sufficient and accurate, and we propose a continuum to classify participants based on participants' overall trend of posting activities. In order to further online community research, we also propose potential directions for future studies.
cs.SI
cs
International Journal of Managing Information Technology (IJMIT) Vol.4, No.1, February 2012 CLASSIFY PARTICIPANTS IN ONLINE COMMUNITIES Xuequn Wang1 and Yanjun Yu2 1Department of Management, Information Systems & Entrepreneurship, Washington State University, Pullman, WA, USA [email protected] 2Department of Management Information Systems, Southern University at New Orleans, New Orleans, LA, USA [email protected] ABSTRACT As online communities become increasingly popular, researchers have tried to examine participating activities in online communities as well as how to sustain online communities. However, relatively few studies have tried to understand what kinds of participants constitute online communities. In this study, we try to contribute online community research by developing “common language” to classify different participants in online communities. Specifically, we argue that the previous way to classify participants is not sufficient and accurate, and we propose a continuum to classify participants based on participants’ overall trend of posting activities. In order to further online community research, we also propose potential directions for future studies. KEYWORDS Online communities, Contributors, Lurkers, Content contribution 1. INTRODUCTION Advances in information and communication technologies (ICT) are changing individuals’ life, and a new trend since 21st century is online communities. Online communities enable individuals not only to post user generated content (UGC) such as feedback, opinions and personal information [1], but also exchange information with others who they may never meet. Researchers have examined how online communities shape individuals’ daily life and what the implications are for practitioners and researchers [19]; how to transfer users of collaborative websites into contributors [1]; and the needs, i.e., recognition and appreciation of their contribution, promotional opportunities or because of sense of responsibility, of the knowledge sharing in online communities inside or outside of an organization [18]. While previous studies have tried to understand participating activities in online communities as well as how to sustain online communities [11, 32], relatively few studies have tried to classify participants in online communities [10, 28]. Further, previous studies mainly focus on those participants who answer questions or contribute content to online communities, there are no established terminologies for participants who engage in other activities (e.g., make comment, provide feedback). Although there is a kind of individuals called lurker, the term “lurker” may not be suitable in many contexts; given that those individuals do engage in certain activities in online communities, and these activities can also be important to online communities. DOI : 10.5121/ijmit.2012.4101 1 International Journal of Managing Information Technology (IJMIT) Vol.4, No.1, February 2012 Therefore, in this paper, we try to contribute online community research by classifying different participants in online communities. In our study we use individuals and participants interchangeably, and use information to refer to useful and valuable content, and content to refer to all of the posts from online communities. There are different types of online communities [7], and individuals go to online communities for different purposes. Our study only focuses on those online communities where participants share and exchange information with one another [14], and other types of online communities (e.g., discussion board for online education, online social networks) are beyond the scope of this study. We admit that our study is only an initial step toward deeper understanding of participants in online communities. The rest of the paper is organized as follows. First, we conduct a brief review of previous literature. We then analyze posts from one online community, and classify them into different types. Next, we try to clarify the exact meanings of contribute and lurk. Based on these discussions, we propose a continuum to classify participants in online communities. Finally, we discuss the implications for future studies. 2. AN OVERVIEW OF PARTICIPANTS IN ONLINE COMMUNITIES 2.1 Contributors Many previous studies classify (or just mentions) two types of participants in online communities: contributors (or poster) and lurkers [22, 28]. While the concept of contributors receives little debate, there are competing ideas about who the lurkers really are. For example, Tedjamulia et al. [28] refer lurkers to two types of individuals: (1) those who just view posts; (2) those who do not find a specific type of information and ask for it. In another study, Takahashi et al. [27] refer lurkers to those who do not post any message. Preece et al. [22, p.202] even go one step further and argue that a lurker is “someone who has never posted in the community to which he/she belongs”. Therefore, there are debates about the definition of lurker. To better understand the concept of contributor and lurker, we first go through Merriam-Webster dictionary to find out what contribute and lurk exactly mean. There are three meanings for contribute: 1) to give or supply in common with others (e.g., contribute money to a cause); 2) to supply (as an article) for a publication; 3) to play a significant part in bringing about an end or result (e.g., many players have contributed to the team's success). Based on abovementioned meanings, the meaning of contributor in online communities is derived from the second and third meaning. Specifically, previous literature considers participants providing new information play a significant part in sustaining online communities, and therefore calls them “contributors”. After all, without valuable information, online communities cannot attract other participants and are likely to fail [32]. However, these discussions bring another question: are there other ways to help sustain online communities by providing some “content”? Online communities allow individuals to interact with each other [2]. In such a conversational environment, individuals “create and share knowledge through dialog with questions and answers” [30, p. 266]. Phang et al. [20, p. 721] also argue that the value of online communities depends on “ongoing participation in terms of two key activities i.e., knowledge seeking and contribution”. Therefore, participants who ask questions may also help sustain online community by finding what information is not available and initiating interaction among participants. In other words, besides contributors, there are other types of participants who can also help sustain online communities. 2 International Journal of Managing Information Technology (IJMIT) Vol.4, No.1, February 2012 In fact, recent studies begin to pay more attention to other types of participants. For example, Majchrzak et al. [16] categorize contributors into two kinds: “synthesizers” and “adders”. Synthesizers are those mainly to influence other (wiki) users (e.g., influence the task by finding a new solution), while adders mainly provide new information. Clearly, synthesizers also help sustain online communities. Besides, information that is useful to one individual may be distracting to another [3], and other types of participants can help clarify the usefulness of the information. To summarize, other participants actively engaging in online communities can also supply some “content” and help sustain online communities. Therefore, previous definitions on contributor [28] are limited, and participants in online communities need to be classified further. 2.1 Lurkers Next we examine the definition of lurker. According to Merriam-Webster dictionary, there are four meanings for lurk: 1) to lie in wait in a place of concealment; 2) to move furtively or inconspicuously; 3) to persist in staying; 4) to read messages on an Internet discussion forum (as a newsgroup or chat room) without contributing. Based on these meanings mentioned above, lurkers are those who just read posts in online communities (fourth meaning). That meaning is derived from the first meaning of lurk, stating that lurkers are those who hide from other individuals in online communities. This explanation is consistent with the first kind of lurkers from Tedjamulia et al. [28], but not consistent with their second one. Researchers also realize that there are different types of lurkers. For example, Dennen [6] argues that there are four different types of lurkers: 1) individuals who do not post anything; 2) individuals who read but do not post in a given discussion; 3) individuals who are new and not ready to post; 4) individuals who never want to post. The result of this study implies that individuals go to online communities with different purposes, and the overall trend of activities from individuals are probably more accurate to classify their roles in online communities since the overall trend of activities can better represent individuals’ purposes to go to online communities. In other words, participants who are new to the online communities should be treated as lurkers in a traditional sense because these participants are not ready yet. Once these participants are familiar with the online community, they are likely to contribute and post useful information. To summarize, the definition of contributors and lurkers remains debatable, and we need to classify participants in more depth. To achieve that goal, we first try to understand the activities in online communities by examining posts in an online community and develop a schema to classify these posts. 3. EXAMINE ACTIVITIES IN ONLINE COMMUNITIES In this part, we examine activities (posts) in online communities. Although some studies consider electronic environment suffering from social cue deficiencies [23, 25, 26], other studies also find that even “plain” media such as email can contain rich communication information [17]. Therefore, it is fairly important to understand how individuals participants in online communities. In a recent study, Hrastinski [10] lists six ways of participants: 1) participation as accessing environments; 2) participation as writing; 3) participation as quality writing; 4) participation as writing and reading; 5) participation as actual and perceived writing; 6) participation as taking 3 International Journal of Managing Information Technology (IJMIT) Vol.4, No.1, February 2012 part and joining in a dialogue. Based on this list, writing and posting is an important way to participate, and we try to classify different posts from participants. To examine activities and classify posts, we select DIS Discussion Forums (www.disboards.com) as the sources of posts. DIS Discussion Forum (DIS) is one of the largest and liveliest Disney forums. Participants in DIS share information and discuss a variety of topics such as Disney theme parks, resorts and Disney Cruise Line with each other. Therefore, DIS is consistent with our focus and is a good example to examine online communities where participants share information. We select post as the analysis unit since the basic unit in online communities is a “comment-by- participant-on-topic-at-time” [31]. Also, we focus on dialog in this study, which is one of the two paradigms for the sharing and distribution of information in online communities [31]. By analyzing the posts from DIS during November and December in 2010, we classify posts of DSI into seven categories (see Table 1): Table 1. Post Types Post Type Short description Post Type I Post Type II Post Type III Post Type IV Posts which provide new information Posts which ask questions Response posts which answer questions Response posts which provide feedback Response posts which thank for help Response posts which say something bad Post Type N Viewing without posting Post Type VI Post Type V Position in a thread Affect Explicit or Implicit In the beginning Neutral Explicit Anywhere Neutral Explicit In the middle Neutral Explicit In the middle Neutral Explicit In the middle Positive Explicit In the middle Negative Explicit N/A Negative Implicit 3.1 Posts which provide new information (Post Type I): When individuals have some new information to share, they may put the information in a single post. The post usually appears in the beginning of a thread. We refer this kind of posts to “Post Type I”. “Post Type I” provides interesting or valuable information and is usually relevant to other participants from the same online community. For example, here is an example from DIS: “This thread is intended to discuss most aspects of Walt Disney World (WDW) ticketing…” In fact, that post is so useful that the administrator put it at the top of one subforum. 3.2 Posts which ask questions (Post Type II): Online communities cannot contain every piece of information for which their participants look. Even if the relevant information does exist, that piece of information may be quite difficult for participants to locate. Therefore, individuals sometime (start threads and) ask questions. We refer this kind of posts to “Post Type II”. For example, here is a post from DIS: 4 International Journal of Managing Information Technology (IJMIT) Vol.4, No.1, February 2012 “Hi! I'm planning my first trip to Disney with my family. I would like to be able to find out which characters will be where and when, so I can make the most of each park we visit. I'm sure in the MK they will be everywhere, but I would especially love to know when Mike and Sully and the Cars characters will be appearing in HS.” Since participants from the same online community usually share similar interests, other participants may also want to ask the same or similar question. If the information required is indeed not available, others may answer the question and thus increase the information base of online communities (refer to Post Type III). 3.3 Response posts which answer questions (Post Type III): When someone asks a question, other participants may know the answer and response to that question, by either providing relevant information directly or referring to previous posts if the answer already exists. We refer this kind of posts to “Post Type III”. For example, here is one of answers from DIS to the example question of the Post Type II: “You can also ask at guest services once you are in the park. They can tell you when where and if a character will be there that day.” Post Type III is often context-based. However, Post Type III does contain valuable and useful information, and increases the information base of online communities, which you can see from the above example. Post Type III also functions as the intermediary connecting participants who have questions to those who know answers. 3.4 Response posts which provide feedback (Post Type IV): After participants who ask questions get answers, they may not feel that their questions are really answered. The reason may be that individuals who give answers misunderstand the questions, or that those participants who ask the questions need clarification. In these situations, participants who ask questions provide feedback through response posts. We refer this kind of posts to “Post Type IV”. “Post Type IV” can also come from individuals who try to answer questions, but find that they need more details. For example, here are three sequential posts from DIS. A: “…can anyone tell me what time the Jedi Academy is held each day??” (Post Type II) B: “My strategy would be to arrive at Rope Drop, ride TSM or fastpass then sprint to Jedi Academy and wait.” (Post Type III) A: “Where exactly is this in the park? My 7y/o is SW obsessed and has every light saber known to man, lol” (Post Type IV) Although Post Type IV can also be a question, it should not be equal to Post Type II. The purpose of Post Type II is to get some new information, while that of Post Type IV is to clarify and achieve mutual understanding. Another possibility is that someone posts something and others express what they think about it. For example: A: “Check out this website its like people of walmart only at Disneyworld, to funny, http://www.peopleofthepark.com/” (Post Type I) 5 International Journal of Managing Information Technology (IJMIT) Vol.4, No.1, February 2012 B: “People of the Park is interesting, but a little on the mean side. Maybe I'm just scared I'll show up on there!” (Post Type IV) C: “Me, too. I can think of one specific instance this past July. It has to do with a matching shirt I was guilted into wearing.” (Post Type IV) Post Type IV is usually the middle stage between Post Type II and Post Type III. Sometimes Post Type IV is not needed, while sometimes many Post Type IV posts are needed to clarify the contexts. These posts may not contain any valuable information, but are important to make “conversation” between participants keep going and get answers finally. Post Types I to IV are affective neural, from the perspective of contributors1. 3.5 Response posts which thank for help (Post Type V): When participants who ask questions receive answers that they want, they probably appreciate the help and effort from others. We refer this kind of posts to “Post Type V”. For example, here is an example from DIS: “awesome! thanks for the help. I haven't checked the links yet, but heading there now. Great maps, Robo!” Based on the above example, we can tell that the Post Type V post usually contains positive affect to contributors. 3.6 Response posts which say something bad (Post Type VI): Sometimes participants may feel angry (about previous posts) and throw bad words into online communities. We refer this kind of posts to “Post Type VI”. Post Type VI post usually contains negative affect to contributors. Although we did not find such type of posts in DIS during analyzing, we do come across them occasionally from other contexts and decide to include this type to make our classification more complete. 3.7 Viewing without posting (Post Type N) Individuals may simply view rather than post something in the online communities. We refer this kind of “posts” to “Post Type N”. Post Type N is not a real post. However, some changes may occur after viewing. For example, some online communities have the function to count how many times individuals have viewed a thread. So even if individuals just view posts, this kind of “post” will increase the count of viewing by one. Some contributors may feel honoured that others take time to go through their posts even without responses. However, we consider Post Type N to be implicitly affectively negative to contributors for the following reasons: in many cases administrators encourage responses, and many participants who contributed information in the online communities ask others how they feel about the information were posted. If other participants just view the posts without providing any response or feedback, the online community contributors don’t know whether the information they provide need further modification or clarification. Thus, viewing without posting do not help contributors understand how useful their information is. We admit that just examining one online community is a limitation of this study. Nevertheless, we believe that most of the post types identified can be also applied to other contexts. Please also 1 Given that content contribution is one of the central interests in online community research [32], we choose to view posts from the perspective of contributors. 6 International Journal of Managing Information Technology (IJMIT) Vol.4, No.1, February 2012 note that some posts may be multi-type. For example, one post can both comment on the previous posts and raise a new question. 4. A CONTINUUM OF PARTICIPANTS IN ONLINE COMMUNITIES Takahashi et al. [27] argue that there are five factors which can be used to classify participants from online communities, including expectations of purpose of an online community, stance on participation, personal specialty and interests, attitude towards information handling, and awareness of the existence of others. To separate individuals into meaningful subdivision, as well as keep the classification parsimonious enough, we argue that classification of participants in online communities should be based on their overall activities (or tendency) in a certain time period, and the value2 of different types of participants to a certain online community are indeed along a continuum (refer to figure 1). This criterion is consistent with expectations of purpose and stance on participation from Takahashi et al. [27]. Thus, we classify all individuals from a certain online community (we refer it to X Community in this part) into seven categories. Figure 1. A Continuum of Participants in Online Communities Outsider: Individuals who do not know X community. They may or may not be interested in the content from the X community. Non-interested knower: Individuals who know X community but never browse its posts. They are currently not interested in the content from the X community. They may become interested in the content from the X community in the future. This concept is consistent with the concept of shirkers from Egan et al. [8]. Trouble maker: Individuals who post bad words (Post Type VI) in X community. Once individuals put Post Type VI posts, which can hurt the X community by letting other participants feel bad. Therefore, even if these individuals may provide new information sometimes (Post Type I or III), they are not desired by the X community because other participants may leave the X community because of Post Type VI posts. Lurker: Individuals who just consume without providing any new information. In other words, they just “put” Post Type N. While they increase the total number of visiting of X community, they also generate Post Type N posts. Therefore, their overall value to the X community is roughly zero. 2 We define value as the degree to which individuals help sustain online communities. 7 International Journal of Managing Information Technology (IJMIT) Vol.4, No.1, February 2012 Non-contributing Participants: Individuals who do not provide any new information, but consume information or participate in other activities. They can ask questions (Post Type II), give feedback (Post Type IV), and thank others (Post Type V). Partial-contributing Participant: Individuals who contribute sometimes, but they usually consume information from X community or participate in other activities. These participants still provide new information (Post Type I) or answer questions (Post Type III) sometimes, but they usually read posts or participate in other activities (Post Type II, IV, and V). Contributor: Individuals who provide new information (Post Type I and III) regularly. They do spend some time browsing posts, but their main activities are contributing. In the continuum, we try to avoid the confusion of the “contribute” concept discussed early by explicitly adding the term “participate”. Thus, we differentiate other activities (Post Type II, IV, and V) from providing new information (Post Type I and III), and narrow the meaning of “contribute”. We put non-interested knower closer to the X community than outsider because the non-interested knowers at least know the existence of the X community. In a certain study researchers can define the exact meaning of time period according to their research questions and interests. For example, if one study wants to examine participants’ monthly activity pattern, then the time period is one month and classification of participants can accord to their overall activities in every month. Although it is tempting to have individuals who just contribute, this type of individuals cannot exist in the reality. To answer questions, individuals have to go through other participants’ posts. Even for those who often provide information spontaneously (Post Type I), these contributors also want to read others’ responses to see how others think about their posts or if there is something missing in their posts. 5. WHAT ONLINE COMMUNITIES NEED IN DIFFERENT STAGES Given that only partial-contributing participants and contributors actively contribute in online communities, these two kinds of participants are probably the most desired in online communities3. However, online communities may vary in the stage of their life cycles [21]. Therefore, online communities may want to put different emphasis on different types of participants in different stages. Table 2 lists the short description of each stage, and Figure 2 shows how the number of participants changes in each stage. Below we provide a more detailed discussion of each stage. 3 Here we do not mean that non-contributing participants are not desired at all. As we discussed early, these participants do have values to the online community, but their value is relatively less than that of partial- contributing participants and contributors. 8 International Journal of Managing Information Technology (IJMIT) Vol.4, No.1, February 2012 Table 2. Different Stages Of Online Community Life Cycle Stage Attraction Build-Up Maintenance Short description Online communities start to launch; Contributors provide much interesting information, and individuals from outside are attracted. As more and more individuals are attracted, they begin to build up the relationship with online communities and participate regularly. The number of participants passes a critical mass; the number of daily posts is so large that online communities focus more on the maintenance of posts. Deterioration/ End The rate of providing new information is decreasing; participants start to leave online communities and stop participating. Figure 2. Online Communities in Different Stages During the early stages (Attraction and Build-Up), online communities just start and need to attract more individuals. Since the useful and interesting information of the online communities is the key to attract individuals outside, contributors are most desired [32]. During these stages, the number of participants is not large enough and there is not enough information in the online communities. If most participants just comment instead of providing new information, the information from the online communities may become out of date soon and participants may find that there is not much to gain [22]. Therefore, partial-contributing participants are less desired during this stage, and the online communities need many contributors who contribute a lot and regularly. When online communities become mature, and the size of participants becomes large enough (exceeds a critical mass), the emphasis of the online communities probably switches to maintenance, and other types of participants are more desired than those of early stages. Butler [3] points out that the main focus of online communities comes to the maintenance with the growth of community size. In Wiki context, Kittur et al. [13] find that as the size of Wikipedia grows, the rate of creating new information is decreasing, while the amount of maintenance work is increasing. Viégas et al. [29] also notice that the fastest growing area of Wikipedia is group coordination, which Wikipedia community places a strong emphasis on, and group coordination supports strategic planning of edits and enforcement of standard guideline. Therefore, in the stage of maintenance, non-contributing and partial contributing participants become more important. 9 International Journal of Managing Information Technology (IJMIT) Vol.4, No.1, February 2012 They may provide little new information, but they actively engage in maintenance-related activities. Non-contributing and partial contributing participants can also be important to contributors. Contributors need other individuals to participate (e.g., join the “conversation”) to help them keep contributing. Butler et al. [4] point out that the most fundamental investment in online communities is active participation, including posting content, responding to posts, and organizing discussion. From a collaboration standpoint [5], contributors need confirmation from other individuals once they provide some information. From a resource standpoint, membership size is a kind of resource: audience resource. When contributors provide new information, they also look for audiences’ ideas. In other words, they compete with audience resource [3], and need other individuals to recognize their effort of providing new information [11, 12, 32]. Further, Non-contributing and partial contributing participants can help identify what pieces of new information are needed. Hahn and Subramani [9] point out that knowing a prior what information will be requested is quite challenging. That is especially true for online communities. In such a context, Post Type II can be useful. These arguments are consistent with the concept of conversational knowledge management [30]. Wagner and Bolloju [31] also argue that online communities carry out knowledge creation and sharing through a process of discussion with questions and answers (discussion forum), collaborative editing and maintenance (Wikipedia), or storytelling (weblogs). Therefore, the situation becomes much more complex during the maintenance stage. While online communities still need Post I and III posts, other types of post (Post Type II, IV and V) are more desired than Post I and III in later stages, and the online communities need to balance these activities carefully. Meanwhile, post type VI is not desired and even prohibited. Here, editorial content control can screen out these unwelcomed activities [3]. Therefore, even after the online communities move to the stage of maintenance, these communities are not guaranteed to success forever. Without careful monitoring and maintenance, online communities may deteriorate and end. Although lurkers are not desired, we do not mean that individuals should not view and consume information. In fact, consuming information is one type of participations, and online communities will not remain viable if individuals do not regularly consume the information that contributors provide [4]. However, after individuals consume information, they are desired to give contributors feedback (Post Type IV) or thank contributors (Post Type V). Viewing with posting (Post Type N) may not be desired. The discussion above focuses on those participants who are active in online communities in a certain way. Does it mean that there is nothing to do with outsiders, non-interested knowers and lurkers? Probably not, and we argue that those three types of individuals can be as interesting as partial-contributing participants and contributors. In the next part we provide a few potential research directions for those types of individuals. 6. IMPLICATIONS FOR FUTURE STUDIES In this part, we propose a few potential research directions, which we hope can give some insights to further online community research. Previous research mainly focuses on the factors to motivate individuals to contribute. In other words, researchers are mainly interested in “converting” lurkers, non-contributing participants to partial-contributing participants and even contributors. While we fully agree that this stream of research is quite important for online community research, we also realize that mainly focusing on contributors may be limited. Before online communities even encourage individuals to actively participate, these individuals need to know the online communities. Therefore, one interesting question can be “What initiatives can help online communities be known by more individuals?” After all, potential 10 International Journal of Managing Information Technology (IJMIT) Vol.4, No.1, February 2012 contributors cannot become resource of online communities if they do not even know those online communities. Many online communities are interest-based, and their participants generally share similar interests. Therefore, non-interested knowers are probably not interested in the content of that online community4. However, while some online communities organize all content under a shared theme (e.g., all subforums of DIS are related to Disney Park), others may have several loosely organized subforums and cover many different areas of content such as sports, movie, and politics (e.g., the discussion board in sina.com). In such a context, individuals actively participating in a few subforums may never visit other subforums. Therefore, one interesting question is “Is it possible (or beneficial) to include more subforums and attract more individuals?” Clearly, adding another subforum can potentially increase the size of participants. However, the cost of organizing and maintaining can also go up. Managers of online communities should carefully balance the cost and the benefit when considering such decisions. Even if lurkers just consume information without posting, online communities can still impact lurkers by influencing their daily life. Therefore, researchers may want to examine lurkers’ daily life outside online communities, and divide lurkers into different sub-types, based on the impact of online communities. For example, Willett [33] divides lurkers into two kinds: active lurkers who make direct contact with posters or propagate information gained, and passive lurkers who only read for their own use. Based on Willet’s study, Takahashi et al. [27] further divide active lurkers into two types: active lurkers as propagators, who “propagates information or knowledge gained from an online community to others outside it”, and active lurkers as practitioners who “uses such information or knowledge in their own or organizational activities”. They also classify passive lurkers into two types: active lurker candidates and the persistent lurkers based on “whether the online community affects the lurker’s thought”. Therefore, one interesting question is “How can online communities impact lurkers’ daily behaviours?” Recent studies have begun to understand the effect of online communities on lurkers in the context of learning. For example, Dennen [6] showed that students learned through reading messages in the online discussion board. This research direction is consistent with knowledge management literature. For example Kankanhalli et al. [11] argue that successful knowledge management systems need knowledge seekers to use and reuse the codified knowledge. Lindgren and Stenmark [15] also argue that individuals can hint their friends about what they think interesting and useful by “word-of-mouth” [24]. Therefore, understanding the effect of online communities on lurkers is quite important. 7. CONCLUSIONS Online community research becomes increasingly popular. In this study, we try to develop terminologies to classify participants in online communities. To achieve this goal, we analyze the posts from one online community, and then classify participants along a value continuum. We then propose potential directions for future studies. We hope our study can further the research on online communities. REFERENCES [1] . Abrouk, L., Gross-Amblard, D. & Cullot, N. (2010) “Community Detection in the Collaborative Web”, International Journal of Managing Information Technology, Vol. 2, No. 4, pp1-9. [2] . Brown, J. S., & Duguid, P. (1991) “Organizational Learning and Communities of Practice,” Organization Science, Vol. 2, No. 1, pp40-57. 4 Here the assumption is that the online community is matured and its content coverage is relatively stable. When online communities just begin, their content coverage can change substantially and those online communities are possible to attract non-interested knowers. 11 International Journal of Managing Information Technology (IJMIT) Vol.4, No.1, February 2012 [3] . [4] . [5] . [6] . [7] . [8] . Butler, B. S. (2001) “Membership Size, Communication Activity, and Sustainability: A Resource- Based Model of Online Social Structures,” Information Systems Research, Vol. 12, No. 4, pp346– 362. Butler, B. S., Sproull, L., Kiesler, S., & Kraut, R. (2007) “Community effort in online groups: who does the work and why,” in: S. P. Weisband (Eds.), Leadership at a Distance: Research in Technologically-Supported Work (pp171-194), Lawrence Erlbaum Publishers, New York, NJ. Clark, H.H., & Brennan, S.E. (1991) “Grounding in Communication,” in: L. Resnick, J. Levine and S. Teasley (Eds.), Perspectives on Socially Shared Cognition (pp127-149), American Psychological Association, Hyatsville, MD. Dennen, V.P. (2008). “Pedagogical lurking: Student engagement in non-posting discussion behavior,” Computers in Human Behavior, Vol. 24, pp1624–1633. DeSanctis, G., Fayard, A.L., Roach, M., & Jiang, L. (2003) “Learning in Online Forums,” European Management Journal, Vol. 21, No. 5, pp565-577. Egan, C., Jefferies, A., & Johal, J. (2006) “Providing fine-grained feedback within an on-line learning system: Identifying the workers from the lurkers and the shirkers,” The Electronic Journal of e-Learning, Vol. 4, No. 1, pp15–24. [9] . Hahn, J., & Subramani, M. R. (2000) “A Framework of Knowledge Management systems: Issues and Challenges for theory and Practice,” in Proceedings of the International Conference on Information systems. [10]. Hrastinski, S. (2008) “What is online learner participation? A literature review,” Computers & Education, Vol. 51, pp1755–1765. [11]. Kankanhalli, A., Tan, B.C. Y., & Wei, K.-K. (2005a) “Contributing Knowledge to Electronic Knowledge Repositories: An Empirical Investigation,” MIS Quarterly, Vol. 29, No. 1, pp113-143. [12]. Kankanhalli, A., Tan, B.C. Y., & Wei, K.-K. (2005b) “Understanding Seeking from Electronic Knowledge Repositories: An Empirical Study,” Journal of the American Society for Information Science and Technology, Vol. 56, No. 11, pp1156-1166. [13]. Kittur, A., Suh, B., Pendleton, B. A., & Chi, Ed H. (2007) “He says, she says: Conflict and coordination in Wikipedia,” in Proceedings of CHI, 2007. [14]. Lee, F., Vogel, D., & Limayem, M. (2002) “Virtual community informatics: What we know and what we need to know,” 35th Hawaii International Conference on System Science, IEEE, Big Island, HI, pp2863–2872. [15]. Lindgren, R., & Stenmark, D. (2002) “Designing Competence Systems: Towards Interest- Activated Technology,” Scandinavian Journal of Information Systems, Vol. 14, pp19-35. [16]. Majchrzak, A., Wagner, C., & Yates, N. (2006) “Corporate wiki users: Results of a survey,” in proceedings of the Second International Symposium on Wikis, Copenhagen. [17]. Ngwenyama, O.K., & Lee, A. S. (1997) “Communication Richness in Electronic Mail: Critical Social Theory and the Contextuality of Meaning,” MIS Quarterly, Vol. 21, No. 2, pp145-167. [18]. Oye, N.D., Sallech, M. & Noorminshah, A. (2011) “Knowledge Sharing in Workplace: Motivators and Demotivators”, International Journal of Managing Information Technology, Vol. 3, No. 4, pp71-84. [19]. [20]. [21]. [22]. Parameswaran, M., & Whinston, A. B. (2007) “Research Issues in Social Computing,” Journal of the Association for Information Systems, Vol. 8, No. 6, pp336-350. Phang, C. W., Kankanhalli, A., & Sabherwal, R. (2009) “Usability and Sociability in Online Communities: A Comparative Study of Knowledge Seeking and Contribution,” Journal of the Association for Information Systems, Vol. 10, No. 10, pp721-741. Preece, J., Maloney-Krichmar, D. & Abras, C. (2003) “History of Emergence of Online Communities,” In B. Wellman (Ed.), Encyclopedia of Community, Berkshire Publishing Group, Sage. Preece, J., Nonnecke, B., & Andrews, D. (2004) “The top five reasons for lurking: improving community experience for everyone,” Computers in Human Behavior, Vol. 20, pp201-223. 12 International Journal of Managing Information Technology (IJMIT) Vol.4, No.1, February 2012 [23]. [24]. [25]. [26]. [27]. Rice, R. E. (1984) “Mediated group communication,” in Rice, R. E. and Associates. (Ed.), The New Media: Communication, Research, and Technology (pp129–156), Sage Publication, Beverly Hills, CA. Shardanand, U. & Maes, P. (1995) “Social Information Filtering: Algorithms for Automating ‘Word of Mouth’,” in Proceedings of CHI 1995, ACM Press, Denver, pp210-217. Short, J., Williams, E., & Christie, B. (1976) The Social Psychology of Telecommunications, Wiley, New York. Sproull, L., & Kiesler, S. (1986) “Reducing social context cues: Electronic mail in organizational communication,” Management Science, Vol. 32, No. 11, pp1492-1512. Takahashi, M., Fujimoto, M., & Yamasaki, N. (2003) “The Active Lurker: Influence of an In- house Online Community on its Outside Environment,” in Proc. GROUP03. [28]. Tedjamulia, S.J.J., Olsen, D.R., Dean, D.L., & Albrecht, C.C. (2005) “Motivating Content Contributions to Online Communities: Toward a More Comprehensive Theory,” Thirty-Eighth Hawaii International Conference on System Sciences. [29]. Viégas, F., Wattenberg, M., Kriss, J., & van Ham, F. (2007) “Talk Before You Type: Coordination in Wikipedia,” Fortieth Hawaii International Conference on System Sciences. [30]. Wagner, C. (2004) “Wiki: A Technology for Conversational Knowledge Management and Group Collaboration,” Communications of the Association for Information Systems, Vol. 13, pp265-289. [31]. Wagner, C., & Bolloju, N. (2005) “Editorial Preface: Supporting Knowledge Management in Organizations with Conversational Technologies: Discussion Forums, Weblogs, and Wikis,” Journal of Database Management, Vol. 16, No. 2, ppI – VIII. [32]. Wasko, M. M., & Faraj, S. (2005) “Why Should I Share? Examine Social Capital and Knowledge Contribution in Electronic Networks of Practice,” MIS Quarterly, Vol. 29, No. 1, pp35-57. [33]. Willett, J. (1998) “VECO – An Online Community Making a Difference, an Evaluation of the Project,” Australian Student Traineeship Foundation and Dusseldorp Skills Forum, Sydney. Authors Xuequn (Alex) Wang is a Ph.D. Candidate from the Department of Management, Information Systems, & Entrepreneurship at Washington State University. He received his M.S. in Management Information Systems from Oklahoma State University, and a B.E. from Civil Aviation University of China. His research interests include psychometrics, knowledge management, online communities, and idea generation. His research has been presented at Hawaii International Conference on System Sciences (HICSS), Americas Conference on Information Systems (AMCIS), Western Decision Sciences Institute (WDSI), and JAIS Theory Development Workshop. Yanjun Yu is an assistant professor in the Department of Management Information Systems (MIS) at Southern University at New Orleans. She received her Ph.D. in MIS from Washington State University, a M.S. in Management and Information Technology from California State University Monterey Bay, and a B.A in Business English from Zhengzhou University, China. Her research interests include cross-culture study, global software outsourcing, communication and mobile commerce, etc.. Her research papers have appeared on Electronic Markets, The Data Base for Advances in Information Systems and Communications of the Association for Information Systems (CAIS), and have been presented on many conferences such as I n te rn a t i o n a l A c a dem y o f B u s i ne s s a n d P u b l i c A dm i n i s t ra t i o n D i sc ip l i n e s ( IABPAD ) C on f e r e nce , the Americas Conference on Information Systems (AMCIS), the Conference on Information Science Technology and Management (CISTM), Western Decision Sciences Institute (WDSI), and Pre- International Conference on Information Systems (ICIS), ISAP Workshop. 13
1602.02426
2
1602
2016-02-11T00:26:27
Human Atlas: A Tool for Mapping Social Networks
[ "cs.SI", "physics.soc-ph" ]
Most social network analyses focus on online social networks. While these networks encode important aspects of our lives they fail to capture many real-world connections. Most of these connections are, in fact, public and known to the members of the community. Mapping them is a task very suitable for crowdsourcing: it is easily broken down in many simple and independent subtasks. Due to the nature of social networks -- presence of highly connected nodes and tightly knit groups -- if we allow users to map their immediate connections and the connections between them, we will need few participants to map most connections within a community. To this end, we built the Human Atlas, a web-based tool for mapping social networks. To test it, we partially mapped the social network of the MIT Media Lab. We ran a user study and invited members of the community to use the tool. In 4.6 man-hours, 22 participants mapped 984 connections within the lab, demonstrating the potential of the tool.
cs.SI
cs
Human Atlas: A Tool for Mapping Social Networks Martin Saveski MIT Media Lab [email protected] Soroush Vosoughi [email protected] MIT Media Lab Eric Chu MIT Media Lab [email protected] Deb Roy MIT Media Lab [email protected] 6 1 0 2 b e F 1 1 ] I S . s c [ 2 v 6 2 4 2 0 . 2 0 6 1 : v i X r a ABSTRACT Most social network analyses focus on online social networks. While these networks encode important aspects of our lives they fail to capture many real-world connections. Most of these connections are, in fact, public and known to the mem- bers of the community. Mapping them is a task very suitable for crowdsourcing: it is easily broken down in many sim- ple and independent subtasks. Due to the nature of social networks-presence of highly connected nodes and tightly knit groups-if we allow users to map their immediate con- nections and the connections between them, we will need few participants to map most connections within a community. To this end, we built the Human Atlas, a web-based tool for mapping social networks. To test it, we partially mapped the social network of the MIT Media Lab. We ran a user study and invited members of the community to use the tool. In 4.6 man-hours, 22 participants mapped 984 connections within the lab, demonstrating the potential of the tool. 1. INTRODUCTION Most social network analyses focus on online social net- works, such as Facebook, Twitter, and LinkedIn. While these networks encode important aspects of our social lives, they fail to capture many important real-world connections. For instance, Facebook may capture connections to friends and family, while LinkedIn may capture professional ties. Moreover, most of these data are proprietary and the com- plete social networks are not available to the members of the community themselves. However, most of these connections are public and known to many members of the community. They constitute, what we call, the publicly knowable graph. Two people are con- nected in the publicly knowable graph if they interact with each other and also there are others who can confirm that they know each other. While different parts of the publicly knowable graph may be common knowledge among groups in the community, putting these fragmented pieces together may reveal important insights about the community. The task of mapping the publicly knowable graph is very well suited for crowdsourcing: (i) it is well-structured, and (ii) it has low complexity [5]. It is straightforward to divide and distribute it: we can ask every participant to map their immediate social network (i.e. ego network) and combine Copyright is held by the author/owner(s). WWW'16 Companion, April 11–15, 2016, Montréal, Québec, Canada. ACM 978-1-4503-4144-8/16/04. http://dx.doi.org/10.1145/2872518.2890552. the individual networks to assemble the social network of the entire community. Moreover, the task of building an ego network is simple and does not require any specific skill. One example of a prior attempt to map publicly knowable connections through crowdsourcing for a specific domain is the Mathematics Genealogy Project, which aims to map the mentorship relationships between mathematicians. To maximize the number of connections captured during the mapping process, we have to enable participants not only to map their immediate connections, but also the connec- tions between their connections. This allows us to capture more connections with much fewer participants. Social networks tend to exhibit properties of scale free net- works [1]. The node degree distribution follows a power law, which indicates that highly connected individuals are very likely to occur and dominate the connectivity. Thus, if we have only a few highly connected individuals participating in the mapping process (mapping their immediate connec- tion and the connections between them), we are very likely to capture a substantial fraction of all connections within the community. Moreover, the distribution of clustering coefficients in so- cial networks also follows a power law [6]. This implies that people tend to create tightly knit groups characterized by a relatively high density of connections. Thus, by allowing participants to map the connections between their connec- tions, we need very few individuals from a tightly knit group to map all connections within the group. Potentially, only one person is needed to report all members of the group and the connections within it. Finally, even if many individu- als do not participate in the mapping process, due to the structure of the network, it is very likely that most of their connections will be mapped by others. This, in turn, requires a very specific interface design choice. Instead of just presenting users with a list of names of all the members of the community and allowing them to sort through and report who they know, we have to allow them to build a network and report the connections between their connections. With these ideas in mind, we set out to build the Hu- man Atlas, a web application for mapping social networks. To test it, we decided to map the publicly knowable graph of our own community, the MIT Media Lab. We ran a user study and invited members of the community to use the tool and provide us feedback. In 4.6 man-hours, 22 participants mapped 984 connections within the lab. This demonstrates the power of the tool and its potential for immediate appli- cation. Figure 1: (A) Splash page: introduction to the Human Atlas. (B) Ego view: your immediate network. (C) Physical view: map of the Media Lab. (D) Global view: the entire community network. 2. HUMAN ATLAS USER EXPERIENCE Next, we describe the Human Atlas user experience1. Screen- shots of the main views are shown in Figure 1. Splash Page. The splash page introduces the user to the concept of the publicly knowable graph and the purpose of the tool. It also defines a link as a connection between peo- ple who have interacted with each other. It then invites the user to start mapping the community by giving a short de- scription of each of the different views. From the splash, the user can see the search bar and list of suggestions, which are the primary ways of adding people to one's network. These elements are constant across all four views both to estab- lish visual consistency and to encourage the creation of new connections. Finally, three of the four icons to the left of the suggestions serve as a navigation menu between views, while the fourth acts as a view-dependent help button. Ego View. The ego view is the primary interface for visu- alizing one's immediate network. The user's connections are displayed as nodes in a force-directed layout, in which the size of the nodes and length of the links can be changed to improve readability. Any links between connections will be present in the layout. Connections created by someone else are transparent until confirmation through double clicking. Simple statistics detailing the number of nodes and links in one's network are also provided. Finally, toggling the help highlights the fact that users can add links between two con- nections, a unique aspect of our tool that allows fewer people to fully map the community. 1Demonstration video is available at the following URL: https://youtu.be/OQOUHkJdA-U Physical View. As relationships often exist in physical spaces, the physical view provides a navigable map of the Media Lab. The panels on the left allow users to traverse between floors, with the ability to zoom and pan in each floor. Lab members are placed in their respective office loca- tions, and a new connection can be added by double clicking on his or her avatar. This view can highlight the important role of physical proximity in which relationships we form. It can also act as a directory for finding where friends and collaborators sit. Global View. Finally, the global view presents the current map of the entire network. The user's node is highlighted, and the user's first degree connections have bolded borders. Sub-communities within the global network are color-coded. When a connection is added through recommendation or search, a bold edge between the user and the new node is temporarily created. This view sheds insight into both the community structure and the user's place within it. IMPLEMENTATION DETAILS 3. Algorithms. We use triadic closure recommendations [3] to generate a list of people who the user may interact with. The main intuition behind triadic closure is that if two peo- ple have many connections in common then they are very likely to be connected. The recommendation engine sorts people by the number of shared connections with the peo- ple who are already in the user's network-the more mutual connections, the higher a person is ranked in the list of sug- gestions. To bootstrap the recommendations, we initially suggest people from the user's research group. To minimize the visual clutter when displaying the net- works in the ego and global view, we color densely connected nodes in the same color. We apply the Louvain community detection algorithm [2] to find groups of nodes that have many connections between each other, but are less connected to the other nodes in the graph. The main advantages of this algorithm are both the automatic detection of the optimal number of communities (no need to set that number a pri- ori) and its high clustering accuracy [4]. Technology. The backend was built in Python and de- ployed as a web application using the Flask framework. For the front end visualizations, we used the Javascript library D3. Of note is the force-directed graph layout used for the Ego and Global views, which represents a network through a physical simulation of charged particles and springs con- necting them. This is parameterized by the magnitude of the repulsive charge and the magnitude of a gravity force that keeps nodes centered in the visible area. 4. DESIGN CONSIDERATIONS Definition of a Link. We aimed to provide a definition that would capture meaningful relationships, but not one so restrictive that we would fail to capture the "true" so- cial network. We settled on links connecting people who have interacted with each other. For example, one would be linked to a friend or collaborator. However, one would not be linked to someone he or she knows of but has never interacted with. Heterogeneous Links. Even armed with our definition, we considered the possibility of heterogeneous links. For example, links could have different strengths on a scale of one to five, or they could explicitly specify the nature of the relationship. The latter could help users find potential research connections, while this general scheme would be useful for analyzing the graph and comparing to different social networks. Ultimately, however, we wanted the tool to be as low friction as possible. Having to specify the link type every time could strongly inhibit engagement. We also believed that defining the nature of each link could give rise to valid privacy concerns. However, we have implemented link types in the backend in anticipation that this tool can be adapted for different communities. Confirmation/Privacy of Links. To address privacy con- cerns about what is publicly knowable, links can be con- firmed on either end. When a link has been added by some- one else, the recipient of that link has the option to confirm it on his or her side. Unconfirmed links are shown in the Ego view as transparent nodes. If a link has not been con- firmed by both sides, it will not show up in someone else's ego network. We call this privacy by default. Currently, however, these edges do show up in the global view. While our user study survey results indicated that privacy concerns were not high, our design will allow us to toggle these public edges as needed. Ego view. Force layouts quickly become visually cluttered when the network is too large. To help counteract this, we first chose not to show the user in his or her own graph. Given that this is a view of the ego network, edges to the nodes in the graph are implicit. We also provided sliders to adjust the repulsive charge and size of the nodes. When the nodes become very small, the pictures within disappear and Figure 2: (A) Average time spent per view. (B-C) Survey results, average rating of how useful (B) and fun (C) each view was. only small colored dots remain. This allows users to gain an understanding of the overall clustering and topology of their network. 5. USER STUDY Setup. To understand how users use and perceive the Hu- man Atlas we ran a user study. We invited 29 members of the Media Lab community to try the tool and give us their feedback. The participants were mostly graduate students, with a few faculty and research staff included, and belonged to 9 (out of 25) different research groups. We made sure that there was a mixture of participants from different academic backgrounds, as well as people who have been a part of the lab for different amounts of time. We informed the participants about the study by sending a short invitation email that gave a one-sentence description of the tool and provided links to the web interface and sur- vey. To test whether the tool is intuitive and easy to use, we purposefully gave no instructions. The survey included nine questions (mostly multiple-choice) asking participants' opinions about the different views, quality of the recommen- dations, privacy concerns, and whether they found anything confusing. To gain better insight in how the participants used the tool, we logged the most important user actions: switching views, searching for people, and adding nodes and links. The participants were given five days to try the tool and complete the survey. The participation rate was 75% for using the tool (22 out of 29), and 52% for completing the survey (15 out of 29). Views. The average session was 6.7 minutes, and most participants had only one session. Users spent the most time on the ego view at 7.3 minutes/user, followed by the physical view at 3.3 minutes/user, and finally the global view at 1.5 minutes/user (Figure 2A). This is most likely due to the design of the tool, as the ego view provides the most features and is a natural first stop in the user flow. However, when asked to rate the different views on a scale from 1 (not useful/fun) to 5 (very useful/fun), the majority found the physical view to be the most useful and fun view. As shown in Figure 2B, 46% found the physical view to be the most useful view, with an average rating of 3.5. This was followed by the ego view with 34% and an average rating of 3.4, and then the global view with 20% and an average rating of 2.9. Similarly, 42% of people found the physical view to be most fun, with an average rating of 3.6 (Figure 2C). Adding immediate links. To add nodes to their network, participants mostly used the ego view, with 65% of all im- mediate connections added from this view (Figure 3A). This Splash0.5UsefulFunEgo7.3Ego3.4Ego3.1Physical3.3Physical3.7Physical3.6Global1.5Global2.9Global3.10.5 7.3 3.3 1.5 0 2 4 6 8 Splash Ego Physical Global MinutesViewAverage time spent per view3.4 3.7 2.9 1 2 3 4 5 Ego Physical Global RatingHow useful was each way?not useful very useful 3.1 3.6 3.1 1 2 3 4 5 Ego Physical Global RatingHow fun was each view?not fun very fun ABC community would have privacy concerns. More than half of them (54%) thought that others would be more concerned than them, and the average rating was 2.7. General feedback. Some participants found it confusing that their node is not in their ego network. Others were not clear about the semantics of the links and were unsure whether to add some links or not. A few participants men- tioned that it would be useful to be able to refresh the list of suggestions or mark some suggestions as irrelevant. Figure 3: (A) Number of nodes added per view. (B) Ways of finding the immediate connections. 6. DEMONSTRATION PLAN was followed by the physical view, from which 32% of the immediate connections were added. The global view was al- most not used for this purpose. Again, this is most likely due to the deign of the tool. Very few links were deleted, with most deletions occurring right after they were created. This indicates that link deletion is being used as an undo feature. To find others and add them to their network, participants can use the search box, the list of suggestions, and the phys- ical map of the lab. As shown in Figure 3B, most immediate connections were added from the list of suggestions (52%), followed by search (26%), and the physical view (22%). This aligns with the feedback provided in the survey. When asked to rate the quality of the suggestions on a scale from 1 (not relevant) to 5 (very relevant), 80% of the participants gave a rating of 3 or higher, with average rating of 3.4. Third-party links. One of the key advantages of the Hu- man Atlas is that users can add links between their imme- diate connections. However, before running the user study, we were uncertain whether users would be interested and willing to add these links. To our surprise, 39% of all links captured were links between users' immediate connections. Some found it fun, with one stating "It seemed nice to see how my actual ego network would look like". Confirming links. When a user adds a new connection, only creator's end of the link is confirmed. The user on the other end may confirm the link or delete it. If a link is introduced by a third party (a common connection), then both ends of the link are unconfirmed. We found that 10% of the links were confirmed, out of all the links that could have been confirmed given the users who participated in the study. The reason for this may be the fact that most users used the tool only once, and many of their links were not created when they used it. One way to overcome this is to send users a notification when a link to them is created. Many users who did not participate in the study were also added. Privacy concerns. We asked the participants to rate their privacy concerns about the Human Atlas on a scale from 1 (not concerned at all) to 5 (very concerned). Nearly half (47%) were not concerned at all, and the average rating was 1.9. Some considered the information captured by the tool public, and elaborated "This is public information", or "I felt like this info is available anyways." Others were more concerned, stating "[I] found myself hesitant to map my own social connections in a public way. Didn't feel like my kind of thing." We also asked participants to rate on a scale from 1 to 5 if they thought that others in the Media Lab The audience will be given the opportunity to fully explore the Human Atlas. The goal of the demonstration will be to showcase the tool by allowing the attendees to map the publicly knowable graph of WWW'16. Before the conference, we will pre-populate the database with names and co-authorship relationships by scraping the "accepted papers" section of the WWW'16 conference web- site. During the conference, attendees whose name is not in the database will be given a chance to manually enter their name into the system. All users will also be given the opportunity-but will not be required-to upload their pictures to the tool so that it can be shown in the graph. The complete tool, including its various views and algorithms will be available for the users to explore. The only notable exception is the physical view, which we cannot demonstrate since it is unsuitable for a conference setting where people do not have permanent locations. As more attendees use the tool, the publicly knowable graph of the conference attendees should become more com- plete and reflect the underlying social graph of the confer- ence. 7. FUTURE WORK We plan to add features to allow users to: (i) import con- nections from social media (e.g. Twitter); (ii) mark link suggestions as irrelevant and refine recommendations; (iii) add research interest tags and find potential collaborators. Finally, once we capture the complete network, we are in- terested in comparing it with online social networks, such as those captured by Twitter or Facebook. 8. REFERENCES [1] A.-L. Barab´asi and R. Albert. Emergence of scaling in random networks. Science, 1999. [2] V. D. Blondel, J.-L. Guillaume, R. Lambiotte, and E. Lefebvre. Fast unfolding of communities in large networks. Journal of Statistical Mechanics: Theory and Experiment, 2008. [3] G. Carullo, A. Castiglione, A. De Santis, and F. Palmieri. A triadic closure and homophily-based recommendation system for online social networks. World Wide Web Conference, 2015. [4] S. Fortunato. Community detection in graphs. Physics Reports, 2010. [5] C. Franzoni and H. Sauermann. Crowd science: The organization of scientific research in open collaborative projects. Research Policy, 2014. [6] D. J. Watts and S. H. Strogatz. Collective dynamics of 'small-world' networks. Nature, 1998. Ego522Suggestions35052%Physical258Search17226%Global16Physical view14722%522 258 16 0 100 200 300 400 500 600 Ego Physical Global Number of nodes addedView350 172 147 0 100 200 300 400 Suggestions Search Physical view Number of nodes addedAB
1112.4002
2
1112
2012-08-03T17:10:01
Conjoining Speeds up Information Diffusion in Overlaying Social-Physical Networks
[ "cs.SI", "physics.soc-ph" ]
We study the diffusion of information in an overlaying social-physical network. Specifically, we consider the following set-up: There is a physical information network where information spreads amongst people through conventional communication media (e.g., face-to-face communication, phone calls), and conjoint to this physical network, there are online social networks where information spreads via web sites such as Facebook, Twitter, FriendFeed, YouTube, etc. We quantify the size and the critical threshold of information epidemics in this conjoint social-physical network by assuming that information diffuses according to the SIR epidemic model. One interesting finding is that even if there is no percolation in the individual networks, percolation (i.e., information epidemics) can take place in the conjoint social-physical network. We also show, both analytically and experimentally, that the fraction of individuals who receive an item of information (started from an arbitrary node) is significantly larger in the conjoint social-physical network case, as compared to the case where the networks are disjoint. These findings reveal that conjoining the physical network with online social networks can have a dramatic impact on the speed and scale of information diffusion.
cs.SI
cs
Conjoining Speeds up Information Diffusion in Overlaying Social-Physical Networks Osman Yagan∗, Dajun Qian†, Junshan Zhang†, and Douglas Cochran† ∗ CyLab, Carnegie Mellon University, Pittsburgh, PA 15213. E-mail: [email protected] † School of ECEE, Arizona State University, Tempe, AZ 85287 {dqian, junshan.zhang, cochran}@asu.edu 1 2 1 0 2 g u A 3 ] I S . s c [ 2 v 2 0 0 4 . 2 1 1 1 : v i X r a Abstract -- We study the diffusion of information in an overlay- ing social-physical network. Specifically, we consider the following set-up: There is a physical information network where informa- tion spreads amongst people through conventional communica- tion media (e.g., face-to-face communication, phone calls), and conjoint to this physical network, there are online social networks where information spreads via web sites such as Facebook, Twitter, FriendFeed, YouTube, etc. We quantify the size and the critical threshold of information epidemics in this conjoint social-physical network by assuming that information diffuses according to the SIR epidemic model. One interesting finding is that even if there is no percolation in the individual networks, percolation (i.e., information epidemics) can take place in the conjoint social-physical network. We also show, both analytically and experimentally, that the fraction of individuals who receive an item of information (started from an arbitrary node) is significantly larger in the conjoint social-physical network case, as compared to the case where the networks are disjoint. These findings reveal that conjoining the physical network with online social networks can have a dramatic impact on the speed and scale of information diffusion. Key words: Information Diffusion, Coupled Social Net- works, Percolation Theory, Random Graphs. I. INTRODUCTION A. Motivation Modern society relies on basic physical network infrastruc- tures, such as power stations, telecommunication networks and transportation systems. Recently, due to advances in communication technologies and cyber-physical systems, these infrastructures have become increasingly dependent on one another and have emerged as interdependent networks [1]. One archetypal example of such coupled systems is the smart grid where the power stations and the communication network controlling them are coupled together. See the pioneering work of Buldyrev et al. [2] as well as [3], [4], [5], [6] for a diverse set of models on coupled networks. Apart from physical infrastructure networks, coupling can also be observed between different types of social networks. Traditionally, people are tied together in a physical information network through old-fashioned communication media, such as face-to-face interactions. On the other hand, recent advances of This research was supported in part by the U.S. National Science Foun- dation under NSF grants No. CNS-0905603, CNS-0917087, and by the U.S. Defense Threat Reduction Agency under DTRA grant HDTRA1-09-1- 0032. The material in this paper was presented in part at the 46th Annual Conference on Information Sciences and Systems, Princeton (NJ), March 2012. Internet and mobile communication technologies have enabled people to be connected more closely through online social networks. Indeed, people can now interact through e-mail or online chatting, or communicate through a Web 2.0 website such as Facebook, Twitter, FriendFeed, YouTube, etc. Clearly, the physical information network and online social networks are not completely separate since people may participate in two or more of these networks at the same time. For instance, a person can forward a message to his/her online friends via Facebook and Twitter upon receiving it from someone through face-to-face communication. As a result, the infor- mation spread in one network may trigger the propagation in another network, and may result in a possible cascade of information. One conjecture is that due to this coupling between the physical and online social networks, today's breaking news (and information in general) can spread at an unprecedented speed throughout the population, and this is the main subject of the current study. Information cascades over coupled networks can deeply influence the patterns of social behavior. Indeed, people have become increasingly aware of the fundamental role of the coupled social-physical network1 as a medium for the spread of not only information, but also ideas and influence. Twitter has emerged as an ultra-fast source of news [7] and Facebook has attracted major businesses and politicians for advertising products or candidates. Several music groups or singers have gained international fame by uploading videos to YouTube. In almost all cases, a new video uploaded to YouTube, a rumor started in Facebook or Twitter, or a political movement adver- tised through online social networks, either dies out quickly or reaches a significant proportion of the population. In order to fully understand the extent to which these events happen, it is of great interest to consider the combined behavior of the physical information network and online social networks. B. Related Work Despite the fact that information diffusion has received a great deal of research interest from various disciplines for over a decade, there has been little study on the analysis of information diffusion across coupled networks; most of the 1Throughout, we sometimes refer to the physical information network simply as the physical network, whereas we refer to online social networks simply as social networks. Hence the term coupled (or overlaying, or conjoint) social-physical network. works consider information propagation only within a single network. The existing literature on this topic is much too broad to survey here, but we will attempt to cover the works that are most relevant to our study. To this end, existing studies can be roughly classified into two categories. The first type of studies [8], [9], [10], [11], [12], [13] are empirical and analyze various aspects of information diffusion using large- scale datasets from existing online social networks. Some of the interesting questions that have been raised (and answered) in these references include "What are the roles of behavioral properties of the individuals and the strength of their ties in the dynamics of information diffusion" [10], [11], "How do blogs influence each other?" [13], and "How does the topology of the underlying social network effect the spread of information?" [11]. The second type of studies [14], [15], [16], [17], [18], [19], [20] build mathematical models to analyze the mechanisms by which information diffuses across the population. These refer- ences study the spread of diseases (rather than information) in small-world networks [17], [18], scale-free networks [19], and networks with arbitrary degree distributions [20]. However, by the well-known analogy between the spread of diseases and information [21], [22], [23], their results also apply in the context of information diffusion. Another notable work in this group is [24] which studies the spread of rumors in a network with multiple communities. Setting aside the information diffusion problem, there has been some recent interest on various properties of coupled (or interacting or layered) networks (see [3], [25], [26], [27], [28]). For instance, [3], [25] and [26] consider a layered network structure where the networks in distinct layers are composed of identical nodes. On the other hand, in [27], the authors studied the percolation problem in two interacting networks with completely disjoint vertex sets; their model is similar to interdependent networks introduced in [2]. Recently, [28] studied the susceptible-infectious-susceptible (SIS) epi- demic model in an interdependent network. C. Summary of Main Contributions The current paper belongs to the second type of studies in- troduced above and aims to develop a new theoretic framework towards understanding the characteristics of information dif- fusion across multiple coupled networks. Although empirical studies are valuable in their own right, the modeling approach adopted here reveals subtle relations between the network parameters and the dynamics of information diffusion, thereby allowing us to develop a fundamental understanding as to how conjoining multiple networks extends the scale of information diffusion. The interested reader is also referred to the article by Epstein [29] which discusses many benefits of building and studying mathematical models; see also [30]. For illustration purposes, we give the definitions of our model in the context of an overlaying social-physical network. Specifically, there is a physical information network where in- formation spreads amongst people through conventional com- munication media (e.g., face-to-face communication, phone calls), and conjoint to this physical network, there are online 2 social networks offering alternative platforms for information diffusion, such as Facebook, Twitter, YouTube, etc. In the interest of easy exposition, we focus on the case where there exists only one online social network along with the physical information network; see the Appendix for an extension to the multiple social networks case. We model the physical network and the social network as random graphs with specified degree distributions [31]. We assume that each individual in a population of size n is a member of the physical network, and becomes a member of the social network independently with a certain probability. It is also assumed that information is transmitted between two nodes (that are connected by a link in any one of the graphs) according to the susceptible- infectious-recovered (SIR) model; see Section II for precise definitions. Our main findings can be outlined as follows: We show that the overlaying social-physical network exhibits a "critical point" above which information epidemics are possible; i.e., a single node can spread an item of information (a rumor, an advertisement, a video, etc.) to a positive fraction of indi- viduals in the asymptotic limit. Below this critical threshold, only small information outbreaks can occur and the fraction of informed individuals always tends to zero. We quantify the aforementioned critical point in terms of the degree distributions of the networks and the fraction of individuals that are members of the online social network. Further, we compute the probability that an information originating from an arbitrary individual will yield an epidemic along with the resulting fraction of individuals that are informed. Finally, in the cases where the fraction of informed individuals tend to zero (non-epidemic state), we compute the expected number of individuals that receive an information started from a single arbitrary node. These results are obtained by mapping the information dif- fusion process to an equivalent bond percolation problem [32] in the conjoint social-physical network, and then analyzing the phase transition properties of the corresponding random graph model. This problem is intricate since the relevant random graph model corresponds to a union of coupled random graphs, and the results obtained in [20], [31] for single networks fall short of characterizing its phase transition properties. To over- come these difficulties, we introduce a multi-type branching process and analyze it through an appropriate extension of the method of generating functions [20]. To validate our analytical results, we also perform extensive simulation experiments on synthetic networks that exhibit sim- ilar characteristics to some real-world networks. In particular, we verify our analysis on networks with power-law degree distributions with exponential cut-off and on Erdos-R´enyi (ER) networks [33]; it has been shown [34] that many real networks, including the Internet, exhibit power-law distributions with exponential cut-off. We show that conjoining the networks can significantly increase the scale of information diffusion even with only one social network. To give a simple example, consider a physical information network W and an online social network F that are ER graphs with respective mean degrees λw and λf , and assume that each node in W is a member of F independently with probability α. If λw = 0.6 and α = 0.2, we show that information epidemics are possible in the overlaying social-physical network H = W∪F whenever λf ≥ 0.77. In stark contrast, this happens only if λw > 1 or λf > 1 when the two networks are disjoint. Furthermore, in a single ER network W with λw = 1.5, an information item originating from an arbitrary individual gives rise to an epidemic with probability 0.58 (i.e., can reach at most 58% of the individuals). However, if the same network W is conjoined with an ER network F with α = 0.5 and λf = 1.5, the probability of an epidemic becomes 0.82 (indicating that up to 82% of the population can be influenced). These results show that the conjoint social-physical network can spread an item of information to a significantly larger fraction of the population as compared to the case where the two networks are disjoint. The above conclusions are predicated on the social net- work F containing a positive fraction of the population. This assumption is indeed realistic since more than 50% of the adult population in the US use Facebook [11]. However, for completeness we also analyze (see Section V) the case where the social network F contains only ⌊nγ⌋ nodes with γ < 1. In that case, we show analytically that no matter how connected F is, conjoining it to the physical network W does not change the threshold and the expected size of information epidemics. Our results provide a complete characterization of the infor- mation diffusion process in a coupled social-physical network, by revealing the relation between the network parameters and the most interesting quantities including the critical threshold, probability and expected size of information epidemics. To the best of our knowledge, there has been no work in the literature that studies the information diffusion in overlay networks whose vertices are neither identical nor disjoint. We believe that our findings along this line shed light on the understanding on information propagation across coupled social-physical networks. D. Notation and Conventions All limiting statements, including asymptotic equivalences, are understood with n going to infinity. The random vari- ables (rvs) under consideration are all defined on the same probability space (Ω, F , P). Probabilistic statements are made with respect to this probability measure P, and we denote the corresponding expectation operator by E. The mean value of a random variable k is denoted by < k >. We use the notation st= to indicate distributional equality, a.s.−−→ to indicate almost sure convergence and p −→ to indicate convergence in probability. For any discrete set S we write S for its cardinality. For a random graph G we write Ci(G) for the number of nodes in its ith largest connected component; i.e., C1(G) stands for the size of the largest component, C2(G) for the size of the second largest component, etc. The indicator function of an event E is denoted by 1 [E]. We say that an event holds with high probability (whp) if it holds with probability 1 as n → ∞. For sequences {an}, {bn} : N0 → R+, we write an = o(bn) as a shorthand for the relation = 0, whereas an = O(bn) means that there exists limn→∞ c > 0 such that an ≤ cbn for all n sufficiently large. Also, we have an = Ω(bn) if bn = O(an), or equivalently, if there an bn 3 exists c > 0 such that an ≥ cbn for all n sufficiently large. Finally, we write an = Θ(bn) if we have an = O(bn) and an = Ω(bn) at the same time. E. Organization of the Paper The rest of the paper is organized as follows. In Section II, we introduce a model for the overlaying social-physical network. Section III summarizes the main results of the paper that deal with the critical point and the size of information epidemics. In section IV, we illustrate the theoretical findings of the paper with numerical results and verify them via extensive simulations. In Section V, we study information diffusion in an interesting case where only a sublinear fraction of individuals are members of the online social network. The proofs of the main results are provided in Sections VI and VII. In the Appendix, we demonsrate an extension of the main results to the case where there are multiple online social networks. II. SYSTEM MODEL A. Overlay Network Model We consider the following model for an overlaying social- physical network. Let W stand for the physical information network of human beings on the node set N = {1, . . . , n}. Next, let F stand for an online social networking web site, e.g., Facebook. We assume that each node in N is a member of this auxiliary network with probability α ∈ (0, 1] independently from any other node. In other words, we let P [i ∈ NF ] = α, i = 1, . . . , n, (1) with NF denoting the set of human beings that are members of Facebook. With this assumption, it is clear that the vertex set NF of F satisfies NF n a.s.−−→ α (2) by the law of large numbers (we consider the case where NF = o(n) separately in Section V). k } and {pf We define the structure of the networks W and F through their respective degree distributions {pw k}. In partic- ular, we specify a degree distribution that gives the properly normalized probabilities {pw k , k = 0, 1, . . .} that an arbitrary node in W has degree k. Then, we let each node i = 1, . . . , n k }) have a random degree drawn from in W = W(n; {pw the distribution {pw k } independently from any other node. Similarly, we assume that the degrees of all nodes in F = F(n; α, {pf k}) are drawn independently from the distribution {pf k, k = 0, 1, . . .}. This corresponds to generating both networks (independently) according to the configuration model [33], [35]. In what follows, we shall assume that the degree distributions are well-behaved in the sense that all moments of arbitrary order are finite. In order to study information diffusion amongst human beings, a key step is to characterize an overlay network H that is constructed by taking the union of W and F. In other words, for any distinct pair of nodes i, j, we say that i and j are adjacent in the network H, denoted i ∼H j, as long as at least one of the conditions {i ∼W j} or {i ∼F j} holds. This is intuitive since a node i can forward information to another node j either by using old-fashioned communication channels (i.e., links in W) or by using Facebook (i.e., links in F). Of course, for the latter to be possible, both i and j should be Facebook users. The overlay network H = W ∪ F constitutes an ensemble of the colored degree-driven random graphs proposed in [36]. Let {1, 2} be the space of possible colors (or types) of edges in H; specifically, we say the edges in Facebook are of type 1, while the edges in the physical network are said to be of type 2. The colored degree of a node i is then represented by an integer vector di = [di w) stands for the number of Facebook edges (resp. physical connections) that are incident on node i. Under the given assumptions on the degree distributions of W and F, the colored degrees (i.e., d1, . . . , dn) will be independent and identically distributed according to a colored degree distribution {pd} such that w], where di f (resp. di f , di df + (1 − α)1 [df = 0](cid:17) · pw pd = (cid:16)αpf dw , d = (df , dw) (3) due to independence of F and W. The term (1 − α)1 [df = 0] accommodates the possibility that a node is not a member of the online social network, in which case the number df of F-edges is automatically zero. i=1 di Given that the colored degrees are picked such that Pn i=1 di f and Pn w are even, we construct H as in [36], [20]: Each f and node i = 1, . . . , n is first given the appropriate number di w of stubs of type 1 and type 2, respectively. Then, pairs of di these stubs that are of the same type are picked randomly and connected together to form complete edges; clearly, two stubs can be connected together only if they are of the same type. Pairing of stubs continues until none is left. B. Information Propagation Model Now, consider the diffusion of a piece of information in the overlay network H which starts from a single node. We assume that information spreads from a node to its neighbors according to the SIR epidemic model. In this context, an individual is either susceptible (S) meaning that she has not yet received a particular item of information, or infectious (I) meaning that she is aware of the information and is capable of spreading it to her contacts, or recovered (R) meaning that she is no longer spreading the information. This analogy between the spread of diseases and spread of information in a network has long been recognized [21] and SIR epidemic model is commonly used in similar studies; e.g., see [22] (diffusion of worms in online social networks), [21] (diffusion of information through Blogs), and [23] (diffusion of files in peer-to-peer file sharing networks), among others. The dynamics of information diffusion can now be de- scribed as in [20]: We assume that an infectious individual i transmits the information to a susceptible contact j with probability Tij where Tij = 1 − e−rij τi. Here, rij denotes the average rate of being in contact over the link from i to j, and τi is the time i keeps spreading the information; i.e., the time it takes for i to become recovered. 4 It is expected that the information propagates over the physical and social networks at different speeds, which mani- fests from different probabilities Tij across links in this case. Specifically, let T w ij stand for the probability of information transmission over a link (between and i and j) in W and let T f ij denote the probability of information transmission ij and over a link in F. For simplicity, we assume that T w T f ij are independent for all distinct pairs i, j = 1, . . . , n. ij and Furthermore, we assume that the random variables rw are independent and identically distributed (i.i.d.) with τ w i probability densities Pw(r) and Pw(τ ), respectively. In that case, it was shown in [20], [37] that information propagates over W as if all transmission probabilities were equal to Tw, where Tw is the mean value of T w ij ; i.e., Tw :=< T w ij >= 1 −Z ∞ 0 Z ∞ 0 e−rτ Pw(r)Pw(τ )drdτ. We refer to Tw as the transmissibility of the information over the physical network W and note that 0 ≤ Tw ≤ 1. In the same manner, we assume that rf i are i.i.d. with respective densities Pf (r) and Pf (τ ) leading to a transmissibility Tf of information over the online social network F. ij and τ f Under these assumptions, information diffusion becomes equivalent to the bond percolation on the conjoint network H = W ∪ F [20], [37]. More specifically, assume that each edge in W (resp. F) is occupied -- meaning that it can be used in spreading the information -- with probability Tw (resp. Tf ) independently from all other edges. Then, the size of an information outbreak started from an arbitrary node is equal to the number of individuals that can be reached from that initial node by using only the occupied links of H. Hence, the threshold and the size of information epi- demics can be computed by studying the phase transition properties of the random graph H(n; α, {pw k}, Tf ) = k}, Tf ) which is obtained by W(n; {pw taking a union of the occupied edges of W and F. More precisely, information epidemics can take place if and only if k}, Tf ) has a giant connected component H(n; α, {pw that contains a positive fraction of nodes in the large n limit. Also, an arbitrary node can trigger an information epidemic only if it belongs to the giant component, in which case an information started from that node will reach to all nodes in the giant component. Hence, the fractional size of the k}, Tf ) gives both giant component in H(n; α, {pw the probability that an arbitrary node triggers an information epidemic as well as the corresponding fractional size of the information epidemic. k }, Tw) ∪ F(n; α, {pf k }, Tw, {pf k }, Tw, {pf k }, Tw, {pf III. MAIN RESULTS A. Information Diffusion in Coupled Graphs with Arbitrary Degree Distributions We now present the main result of our paper characterizes the threshold and the size of the information epidemic in H by revealing its phase transition properties. First, for notational convenience, let kf and kw be random variables independently drawn from the distributions {pf k }, respectively, and k} and {pw let < kf >:= λf and < kw >:= λw. Further, assume that βf and βw are given by βf := < k2 f > −λf λf and βw := < k2 w > −λw λw , (4) and define the threshold function σ⋆ f w by σ⋆ f w (5) = Tf βf + Twβw +p(Tf βf − Twβw)2 + 4αTf Twλf λw Finally, let h1, h2 in (0, 1] be given by the pointwise smallest solution of the recursive equations 2 h1 = h2 = Tf λf Tw λw 1 i Ehhkw Ehkf hkf −1 Ehαhkf 2 i + 1 − Tf 1 + 1 − αi Ehkwhkw −1 2 (6) (7) i + 1 − Tw. Theorem 3.1: Undertheassumptionsjuststated,wehave (i) If σ⋆ ≤ the size of f w k }, Tw, {pf On the other hand, k }, Tw, {pf C1(cid:16)H(n; α, {pw C1(cid:16)H(n; α, {pw 1 then with high probability the largest component satisfies o(n). then k}, Tf )(cid:17) k}, Tf )(cid:17) = Θ(n) whp. if σ⋆ = > 1, f w (ii) Also, 1 n C1(cid:16)H(n; α, {pw −→ 1 − Ehαhkf k}, Tf )(cid:17) k }, Tw, {pf 2 i . 1 + 1 − αi Ehhkw p (8) A proof of Theorem 3.1 is given in Section VI. Theorem 3.1 quantifies the fraction of individuals in the overlaying social-physical network that are likely to receive an item of information which starts spreading from a single individual. Specifically, Theorem 3.1 shows that the critical f w = 1, with point of the information epidemic is marked by σ⋆ f w given by (5). In other words, for any the critical threshold σ⋆ f w > 1 (supercritical regime), an parameter set that yields σ⋆ item of information has a positive probability of giving rise to an information epidemic; i.e., reaching a linear fraction of the individuals. In that case, the probability of a node triggering an information epidemic, and the corresponding asymptotic fraction of individuals who receive the information can be found by first solving the recursive equations (6)-(7) for the smallest h1, h2 in (0, 1] and then computing the expression given in (8). On the other hand, whenever it holds that σ⋆ f w ≤ 1 (subcritical regime), we conclude from Theorem 3.1 that the number of individuals who receive the information will be o(n) with high probability, meaning that all information outbreaks are non-epidemic. It is of interest to state whether or not Theorem 3.1 can be deduced from the phase transition results for random graphs with arbitrary degree distributions (e.g., see [35], [20], [31]). It is well known [35] that for these graphs the critical point of the phase transition is given by E [di(di − 1)] E [di] = 1 5 where di is the degree of an arbitrary node. We next show that this condition is not equivalent (and, indeed is not even a good approximation) to σ⋆ f w = 1. k = e−λf To this end, we consider a basic scenario where F and W are both Erdos-R´enyi graphs [33] so that their degree distributions k = e−λw λk are (asymptotically) Poisson, i.e., we have pw λk and pf k! . Given that each link in F (resp. in W) is f occupied with probability Tf (resp. Tw), the occupied degree of an arbitrary node i in H follows a Poisson distribution with mean Twλw if i 6∈ NF (which happens with probability 1 − α), and it follows a Poisson distribution with mean Tf λf + Twλw − Tf λf Twλw if i ∈ NF (which happens with probability α). When n becomes large this leads to w k! n E [di(di − 1)] α(Tf λf + Twλw)2 + (1 − α)(Twλw)2 = E [di] αTf λf + Twλw . (9) It can be seen that the above expression is not equal to the f w -- As discussed in the next subsec- corresponding quantity σ⋆ tion, for the given degree distributions we have σ⋆ f w, f w is given by (14). For instance, with α = 0.2, where λ⋆ Twλw = 0.6 and Tf λf = 0.8, we have σ⋆ f w = 1.03 while (9) yields 0.89 signaling a significant difference between f w and the approximation given by (9). the exact threshold λ⋆ We conclude that the results established in Theorem 3.1 (for coupled random graphs) go beyond the classical results for single random graphs with arbitrary degree distributions. f w = λ⋆ f w = λ⋆ Aside from the critical threshold and the fractional size of information epidemics, we are also interested in computing the average size of information outbreaks in the subcritical regime for a fuller understanding of information propagation process. In other words, in the case where the fraction of informed individuals tends to zero, we wish to compute the expected number of informed nodes. For a given network with nodes 1, . . . , n, the average outbreak size < s > is given by n s(i), where s(i) is the number of nodes that receive an information started from node i; i.e., s(i) is the size of the largest connected component containing node i. Pn i=1 1 Now, let < s >:=< s(n; α, {pw the average outbreak size in H(n; α, {pw easy to check that k }, Tw, {pf k}, Tf )) > denote k}, Tf ). It is k }, Tw, {pf < s >= Nc Xj=1 1 n (cid:16)Cj (H(n; α, {pw k }, Tw, {pf k}, Tf ))(cid:17)2 (10) where, as before, Cj gives the size of the jth largest com- ponent of the network, and Nc denotes the total number of components. To see (10), observe that an arbitrarily selected node will belong to a component of size Cj with probability Cj/n, in which case an information started from that particular node will create an outbreak of size Cj. Summing over all components of the network, we get (10). In the supercritical regime, we have C1(H) = Ω(n) so that < s >→ ∞. The next result, established in Section VI, allows computing this quantity in the subcritical regime. Theorem 3.2: Letσ⋆ f w ≤ 1.Withtheaboveassumptions,let s1, s2 denotethesimultaneousstablesolutionoftheequations s1 = Tf + βf Tf s1 + λwTf s2 s2 = Tw + αλf Tws1 + βwTws2 Then,theaverageoutbreaksizesatisfies < s > p −→ 1 + αλf s1 + λws2. (11) (12) (13) B. Special Case: Information Diffusion in coupled ER graphs A special case of interest is when both W and F are Erdos- R´enyi graphs [33]. More specifically, let W = W(n; λw/n) be an ER network on the vertices {1, . . . , n} such that there exists an edge between any pair of distinct nodes i, j = 1, . . . , n with probability λw/n; this ensures that mean degree of each node is asymptotically equal to λw. Next, obtain a set of vertices NF by picking each node 1, . . . , n independently with probability α ∈ (0, 1]. Now, let F = F(n; α, λf /(αn)) be an ER graph on the vertex set NF with edge probability given by λf αn . The mean degree of a node in F is given (asymptotically) by λf as seen via (2). Given that the degree distributions are asymptotically Pois- son in ER graphs, this special case is covered by our model k! and presented in Section II-A by setting pw λk pf k = e−λf k! . Thus, Theorem 3.1 is still valid and can be f used to obtain the condition and expected size of information epidemics. However, recent developments on inhomogeneous random graphs [38] enable us to obtain more detailed results than those given by Theorem 3.1 for this special case. k = e−λw λk w Consider now an overlay network model H constructed on the vertices 1, . . . , n by conjoining the occupied edges of W and F, i.e., we have H(n; α, Twλw, Tf λf ) = W(n; Twλw/n)∪ F(n; α, Tf λf /(αn)). Let λ⋆ f w be defined by λ⋆ f w := 1 2 Also, recursive equations (Tf λf + Twλw) (14) 1 + 2q(Tf λf + Twλw)2 − 4(1 − α)Tf λf Twλw. let ρ1, ρ2 be the pointwise largest solution of the ρ1 = 1 − exp {−ρ1(αλwTw + λf Tf ) − ρ2(1 − α)λwTw} ρ2 = 1 − exp {−ρ1αλwTw − ρ2(1 − α)λwTw} (15) with ρ1, ρ2 in [0, 1]. Theorem 3.3: Withtheaboveassumptions,wehave (i) If λ⋆ f w then with high probability, 1, ≤ the size of the largest component satisfies C1(H(n; α, Twλw, Tf λf )) = O(log n); in contrast, f w > 1 we have C1(H(n; α, Twλw, Tf λf )) = Θ(n) if λ⋆ whp, while the size of the second largest component satisfies C2(H(n; α, Twλw, Tf λf )) = O(log n). (ii) Moreover, C1(H(n; α, Twλw, Tf λf )) p −→ αρ1 + (1 − α)ρ2. 1 n A proof of Theorem 3.3 is given in Section VII 6 α = 0.1 α = 0.3 α = 0.5 α = 0.7 α = 1.0 0.1 0.2 0.3 0.4 0.5 0.6 0.7 0.8 0.9 1 λwTw f T f λ 1 0.9 0.8 0.7 0.6 0.5 0.4 0.3 0.2 0.1 0 0 Fig. 1. The minimum λf Tf required for existence of a giant component in H(n; α, Twλw, Tf λf ) versus λwTw forvarious α values. Inother words, each curve corresponds to the boundary of the phase transition for the cor- responding α value. Above the boundary there exists a giant component, but belowitallcomponentshave O(log n) nodes. w/k! and pf k = e−λw λk f w = 1, with the critical threshold λ⋆ k = e−λf λk Theorem 3.3 is a counter-part of Theorem 3.1. This time, the "critical point" of the information epidemic is marked f w given by (14). by λ⋆ f /k!, we have that With pw βf = λf , βw = λw, and it is easy to check that σ⋆ f w = λ⋆ f w so that part (i) of Theorem 3.3 is compatible with part (i) of Theorem 3.1. Also, we find (numerically) that the second parts of Theorems 3.3 and 3.1 yield the same asymptotic giant component size. Nevertheless, it is worth noting that Theorem 3.3 is not a corollary of Theorem 3.1. This is because, through a different technique used in the proofs, Theorem 3.3 provides the sharper bounds C1(H(n; α, Twλw, Tf λf ) = O(log n) (subcritical case) and C2(H(n; α, Twλw, Tf λf ) = O(log n) (supercritical case) that go beyond Theorem 3.1. We observe that the threshold function λ⋆ f w is symmetric in Tf λf and Twλw, meaning that both networks have identical roles in carrying the conjoined network to the supercritical regime where information can reach a linear fraction of the nodes. To get a more concrete sense, we depict in Figure 1 the minimum λf Tf required to have a giant component in H(n; α, Twλw, Tf λf ) versus λwTw for various α values. Each curve in the figure corresponds to a phase transition boundary above which information epidemics are possible. If Tf = Tw = 1, the same plot shows the boundary of the giant component existence with respect to the mean degrees λf and λw. This clearly shows how two networks that are in the subcritical regime can yield an information epidemic when they are conjoined. For instance, we see that for α = 0.1, it suffices to have λf = λw = 0.76 for the existence of an information epidemic. Yet, if the two networks were disjoint, it would be necessary [33] to have λf > 1 and λw > 1. We elaborate further on Theorem 3.3. First, we note from the classical results [33] that ER graphs have a giant com- ponent whenever average node degree exceeds one. This is compatible with part (i) of Theorem 3.3, since the condition for giant component existence reduces to Tf λf > 1 if Twλw = 0 and Twλw > 1 when Tf λf = 0. Finally, in the case where α = 1 (i.e., when everyone in the population is a member of Facebook), the graph H reduces to an ER graph with edge probability Tf λf +Tw λw− leading n to a mean node degree of Tf λf + Twλw in the asymptotic regime. As expected, for the case α = 1, Theorem 3.3 reduces to classical results for ER graphs as we see that p f w = Tf λf + Twλw and 1 −→ ρ1 where ρ1 is the λ⋆ largest solution of ρ1 = 1 − e−ρ1(Tf λf +Tw λw). n C1(H) Tf Tw λf λw n IV. NUMERICAL RESULTS A. ER Networks We first study the case where both the physical information network W and the online social network F are Erdos-R´enyi graphs. As in Section III-B, let H(n; α, Twλw, Tf λf ) = W(n; Twλw/n) ∪ F(n; α, Tf λf /(αn)) be the conjoint social- physical network, where W is defined on the vertices {1, . . . , n}, whereas the vertex set of F is obtained by picking each node 1, . . . , n independently with probability α. The information transmissibilities are equal to Tw and Tf in W and F, respectively, so that the mean degrees are given (asymptotically) by Twλw and Tf λf , respectively. We plot in Figure 2 the fractional size of the giant com- ponent in H(n; α, Twλw, Tf λf ) versus Tf λf = Twλw for various α values. In other words, the plots illustrate the largest fraction of individuals that a particular item of information can reach. In this figure, the curves stand for the analytical results obtained by Theorem 3.3 whereas marked points stand for the experimental results obtained with n = 2 × 105 nodes by averaging 200 experiments for each data point. Clearly, there is an excellent match between the theoretical and experimental results. It the critical threshold for the existence of a giant component (i.e., an information epidemic) is given by Tf λf = Twλw = 0.760 when α = 0.1, Tf λf = Twλw = 0.586 when α = 0.5, and Tf λf = Twλw = 0.514 when α = 0.9. It is easy to check that these values are in perfect agreement with the theoretically obtained critical threshold λ⋆ is also seen that f w given by (14). In the inset of Figure 2, we demonstrate the average outbreak size < s > versus Tf λf = Twλw under the same setting. Namely, the curves stand for the analytical results obtained from Theorem 3.2, while the marked points are obtained by averaging the quantity given in (10) over 200 independent experiments. We see that experimental results are in excellent agreement with our analytical results. Also, as expected, average outbreak size < s > is seen to grow un- boundedly as Tf λf = Twλw approaches to the corresponding epidemic threshold. B. Networks with Power Degree Distributions 7 20 15 10 5 0 0 0.80.8 0.7 0.6 0.5 0.4 0.3 0.2 0.1 ) l a n o i t c a r f ( e z i S t n e n o p m o C t n a i G Avg. outbreak size < s > 0.2 0.4 0.6 0.8 α = 0.1 -- Exp α = 0.1 -- Thm α = 0.5 -- Exp α = 0.5 -- Thm α = 0.9 -- Exp α = 0.9 -- Thm 0 0 0.2 0.4 0.6 λf Tf = λwTw 0.8 1 Fig. 2. Thefractionalsizeofthegiantcomponentin H(n; α, Twλw, Tf λf ) versus Tf λf = Twλw. The curves correspond to analytical results obtained from Theorem 3.3, whereas marked points stand for the experimental results obtained with n = 2 × 105 by averaging 200 experiments for each point. (Inset) Average out-break size < s > versus Tf λf = Twλw under thesame setting. specific example of information diffusion when the physical information network W and the online social network F have power-law degree distributions with exponential cutoff. Specifically, we let pw k = (cid:26) 0 and (cid:0)Liγw (e−1/Γw )(cid:1)−1 k−γw e−k/Γw if k = 0 if k = 1, 2, . . . (16) k = (cid:26) 0 pf (17) where γw, γf , Γw and Γf are positive constants and the normalizing constant Lim(z) is the mth polylogarithm of z; (cid:0)Liγf (e−1/Γf )(cid:1)−1 if k = 0 if k = 1, 2, . . ., k−γf e−k/Γf i.e., Lim(z) = P∞ k=1 zk km . Power law distributions with exponential cutoff are chosen here because they are applied to a variety of real-world networks [20], [27]. In fact, a detailed empirical study on the degree distributions of real-world networks [34] revealed that the Internet (at the level of autonomous systems), the phone call network, the e-mail network, and the web link network all exhibit power law degree distributions with exponential cutoff. To apply Theorem 3.1, we first compute the epidemic threshold given by (5). Under (16)-(17) we find that λf = βf = Liγf −1(e−1/Γf ) Liγf (e−1/Γf ) Liγf −2(e−1/Γf ) − Liγf −1(e−1/Γf ) , Liγf −1(e−1/Γf ) In order to gain more insight about the consequences of Theorem 3.1 for real-world networks, we now consider a Similar expressions can be derived for λw and βw. It is now a f w from (5) simple matter to compute the critical threshold σ⋆ 1 0.9 0.8 0.7 0.6 0.5 0.4 0.3 0.2 0.1 f T f β α = 0.1 α = 0.3 α = 0.5 α = 0.7 α = 1.0 8 20 15 10 5 0 0 1 0.9 0.8 0.7 0.6 0.5 0.4 0.3 0.2 0.1 ) l a n o i t c a r f ( e z i S t n e n o p m o C t n a i G Avg. outbreak size < s > 0.2 0.4 0.6 0.8 α = 0.1 -- Exp α = 0.1 -- Thm α = 0.5 -- Exp α = 0.5 -- Thm α = 0.9 -- Exp α = 0.9 -- Thm 0 0 0.1 0.2 0.3 0.4 0.5 βwT w 0.6 0.7 0.8 0.9 1 0 0 0.2 0.4 0.6 0.8 1 1.2 1.4 β f Tf = β wTw k }, Tw, {pf Fig. 3. Theminimum Tf required fortheexistence ofagiant componentin k } and {pf H(n; α, {pw k } are given by (16) and (17), with γf = γw = 2.5 and Γf = Γw = 10. The Tf and Tw values aremultiplied bythecorresponding βf and βw values to provide a fair comparison with the disjoint network case; under the current settingwehave βf = βw = 1.545. k}, Tf ) versus Tw. The distributions {pw using the above relations. Then, we can use Theorem 3.1(i) to check whether or not an item of information can reach a linear fraction of individuals in the conjoint social-physical network H(n; α, {pw k }, Tw) ∪ F(n; α, {pf k}, Tf ) = W(n; {pw k }, Tw, {pf k}, Tf ). to a have value required k }, Tw, {pf To that end, we depict giant k}, Tf ) versus Tw, in Figure 3 the minimum component in Tf for various α H(n; α, {pw values. In other words, each curve corresponds to a phase transition boundary above which information epidemics are possible, in the sense that an information has a positive probability of reaching out to a linear fraction of individuals in the overlaying social-physical network. In all plots, we set γf = γw = 2.5 and Γf = Γw = 10. The Tf and Tw values are multiplied by the corresponding βf and βw values to make a fair comparison with the disjoint network case where it is required [20] to have βwTw > 1 (or βf Tf > 1) for the existence of an epidemic; under the current setting we have βf = βw = 1.545. Figure 3 illustrates how conjoining two networks can speed up the information diffusion. It can be seen that even for small α values, two networks, albeit having no giant component individually, can yield an information epidemic when they are conjoined. As an example, we see that for α = 0.1, it suffices to have that βf Tf = βwTw = 0.774 for the existence of an information epidemic in the conjoint network H, whereas if the networks W and F are disjoint, an information epidemic can occur only if βwTw > 1 or βf Tf > 1. Next, we turn to computation of the giant component size. 4. k } and {pf k }, Tw, {pf The fractional size of the giant component in Fig. k}, Tf ) versus Tf βf = Twβw. The distributions H(n; α, {pw k } are given by (16) and (17), with γf = γw = 2.5 and {pw Γf = Γw = 10.The Tf and Tw values are multiplied bythe corresponding βf and βw values for fair comparison with the disjoint network case; under the current setting we have βf = βw = 1.545. The curves were obtained analytically via Theorem 3.1, whereas the marked points stand for the experimental results obtained with n = 2 × 105 nodes by averaging 200 experimentsforeachparameterset.Weseethatthereisanexcellentagreement between theoryandexperiments. (Inset)Averageout-breaksize < s > versus βf Tf = βwTw underthesamesetting. We note that Ehhkf Ehkf hkf −1 1 i = i = 1 Liγf (h1e−1/Γf ) Liγf (e−1/Γf ) Liγf −1(h1e−1/Γf ) Liγf (e−1/Γf )h1 . 2 ]. Now, and similar expressions can be derived for E[hkw 2 ] and E[kwhkw−1 any given set of parameters, γf , γw, Tf , Tw, Γf , Γw, α, we can numerically obtain the giant k}, Tf ) by invoking component size of H(n; α, {pw the above relations into part (ii) of Theorem 3.1. k }, Tw, {pf for k }, Tw, {pf To this end, Figure 4 depicts the fractional size of the giant component in H(n; α, {pw k}, Tf ) versus Tf βf = Twβw, for various α values; as before, we set γf = γw = 2.5 and Γf = Γw = 10 yielding βf = βw = 1.545. In other words, the plots stand for the largest fraction of individuals in the social-physical network who receive an information item that has started spreading from a single individual. In Figure 4, the curves were obtained analytically via Theorem 3.1 whereas the marked points stand for the experimental results obtained with n = 2×105 nodes by averaging 200 experiments for each parameter set. We see that there is an excellent agreement between theory and experiment. Moreover, according to the experiments, threshold for the existence of a giant component (i.e., an information epidemic) appears at Tf βf = Twβw = 0.78 when α = 0.1, Tf βf = Twβw = 0.61 when α = 0.5, and Tf βf = Twβw = 0.53 when α = 0.9. These values are in perfect agreement with the theoretically the critical obtained critical threshold σ⋆ f w given by (5). The inset of Figure 4 shows the average outbreak size < s > versus βf Tf = βwTw under the same setting. To avoid the finite size effect (observed by Newman [20] as well) near the epidemic threshold, we have increased the network size up to n = 30 × 106 to obtain a better fit. Again, we see that experimental results (obtained by averaging the quantity (10) over 200 independent experiments) agree well with the analytical results of Theorem 3.2. V. ONLINE SOCIAL NETWORKS WITH o(n) NODES Until now, we have assumed that apart from the physical network W on n nodes, information can spread over an online social network which has Ω(n) members. However, one may also wonder as to what would happen if the number of nodes in the online network is a sub-linear fraction of n. For instance, consider an online social network F whose vertices are selected by picking each node 1, . . . , n with probability nγ−1 where 0 < γ < 1. This would yield a vertex set NF that satisfies NF ≤ nγ(1 + ǫ) (18) with high probability for any ǫ > 0. We now show that, asymptotically, social networks with nγ nodes have almost no effect in spreading information. We start by establishing an upper bound on the size of the giant component in H = W∪F. Proposition 5.1: Let W beagraphonvertices1, . . . , n,and F be a graph on the vertex set NF ⊂ {1, . . . , n}. With H = W ∪ F,wehave C1(H) ≤ C1(W) + C2(W)(NF − 1), (19) where C1(W) and C2(W) are sizes of the first and second largestcomponentsofW,respectively. Proof: It is clear that C1(H) will take its largest value when F is a fully connected graph; i.e., a graph with edges between every pair of vertices. In that case the largest com- ponent of H can be obtained by taking a union of the largest components of W that can be reached from the nodes in NF . 1(W) denoting set of nodes in the largest component With Ci (of W) that can be reached from node i, we have (cid:12)(cid:12)∪i∈NF Ci 1(W)(cid:12)(cid:12) = NF (cid:12)(cid:12)(cid:12)(cid:12)(cid:12)(cid:12) 1 1 C1(H) = (cid:12)(cid:12)∪i∈NF Ci (20) where Cj(W) stands for the jth largest component of W. The inequality (20) is easy to see once we write 1(W)(cid:12)(cid:12) ≤ C1(W) + C2(W) + . . . CNF (W) (W)(cid:12)(cid:12)(cid:12)(cid:12)(cid:12)(cid:12) CNF (j) CNF (i) Xi=1 i−1 [j=1 (W) − where NF (i) is the ith element of NF . The above quantity is a summation of the sizes of NF mutually disjoint components of W. As a result, this summation can be no larger than the sum of the first NF largest components of W. The desired conclusion (19) is now immediate as we note that C2(W) ≥ Cj(W) for all j = 3, . . . , NF . The next result is an easy consequence of Proposition 5.1 and classical results [33] for ER graphs. 9 Corollary 5.1: Let W be an ER graph on the vertices 1, . . . , n andlet F beagraphwhosevertexsetNF satisfies(18) whp.Thefollowingsholdfor H = W ∪ F: (i) If W isinthesubcriticalregime(i.e.,if C1(W) = o(n)), thenwhpwehaveC1(H) = o(n). (ii) IfC1(W) = Θ(n),thenwehave C1(H) = (1 + o(1))C1(W). Proof: It is known [33] that for an ER graph W, it either holds that C1(W) = O(log n) (subcritical regime) or it is the case that C1(W) = Θ(n) while C2(W) = O(log n) (supercritical regime). Under condition (18), we see from (19) that whenever C1(W) = o(n) we have C1(H) ≤ c log n·nγ for some c > 0 and part (i) follows immediately. Next, assume that we have C1(W) = Θ(n). The claim (ii) follows from (19) as we note that lim n→∞ C2(W) · nγ C1(W) = 0 since C2(W) = O(log n). Corollary 5.1 shows that in the case where only a sub- linear fraction of the population use online social networks, an information item originating at a particular node can reach a positive fraction of individuals if and only if information epidemics are already possible in the physical information network. Moreover, we see from Corollary 5.1 that the frac- tional size of a possible information epidemic in the conjoint social-physical network is the same as that of the physical information network alone. Combining these, we conclude that online social networks with nγ (0 ≤ γ < 1) members have no effect on the (asymptotic) fraction of individuals that can be influenced by an information item in the conjoint social- physical network. Along the same line as in Corollary 5.1, we next turn our attention to random graphs W with arbitrary degree distribution [31], [35]. This time we rely on the results by Molloy and Reed [35, Theorem 1] who have shown that if there exists some ǫ > 0 such that max{di, i = 1, . . . , n} ≤ n 1 4 −ǫ (21) then in the supercritical regime (i.e., when C1(W) = Θ(n)) we have C2(W) = O(log n). It was also shown [35] that in the subcritical regime of the phase transition, we have C1(W) = O(w(n)2 log n) whenever max {di, i = 1, . . . , n} ≤ w(n) (22) with w(n) ≤ n 1 8 −ǫ for some ǫ > 0. Now, consider a graph F whose vertex set NF satisfies (18) whp and let W be a random graph with a given degree sequence {di}n i=1 satisfying (21). In view of (19), it is easy to see that C1(H) = (1 + o(1))C1(W) where H = W ∪ F and this provides an analog of Corollary 5.1(ii). It is also immediate that in the subcritical regime, we have C1(H) = o(n) as long as (22) is satisfied and (18) holds for some γ ≤ 3 4 ; this establishes an analog of Corollary 5.1(i) for graphs with arbitrary degree distributions. The above result takes a simpler form for classes of random graphs W studied in Section IV-B; i.e., random graphs where the degrees follow a power-law distribution with exponential cutoff. In particular, the degrees of W be distributed according to (16). It is easy to see that let max{di, i = 1, . . . , n} = O(log n) with high probability so that conditions (21) and (22) are readily satisfied. For the latter condition, it suffices to take wn = O(log n) so that in the subcritical regime, we have C1(W) = O(cid:0)(log n)3(cid:1) . The next corollary is now an immediate consequence of Proposition 5.1. Corollary 5.2: Let W be a random graph whose degrees follow the distribution specified in (16) and let F be a graph whose vertex set NF satisfies (18) whp. The followings hold for H = W ∪ F: (i) IfC1(W) = o(n),thenwhpwehaveC1(H) = o(n). (ii) IfC1(W) = Θ(n),thenwehave C1(H) = (1 + o(1))C1(W). Consider random graphs W(n, {pw VI. PROOFS OF THEOREM 3.1 AND THEOREM 3.2 k }) and F(n; α, {pf k}) as in Section III-A. In order to study the diffusion of information in the overlay network H = W ∪ F, we consider a branching process which starts by giving a piece of information to an arbitrary node, and then recursively reveals the largest number of nodes that are reached and informed by exploring its neighbors. We remind that information propagates from a node to each of its neighbors independently with probability Tf through links in F (type-1) and with probability Tw through links in W (type-2). In the following, we utilize the standard approach on generating functions [31], [20], and determine the condition for the existence of a giant informed component as well as the final expected size of the information epidemics. This approach is valid long as the initial stages of the branching process is locally tree-like, which holds in this case as the clustering coefficient of colored degree-driven networks scales like 1/n as n gets large [39]. We now solve for the survival probability of the aforemen- tioned branching process by using the mean-field approach based on the generating functions [31], [20]. Let h1(x) (resp. h2(x)) denote the generating functions for the finite number of nodes reached and informed by following a type-1 (resp. type-2) edge in the above branching process. In other words, we let h1(x) = P vmxm where vm is the "probability that an arbitrary type-1 link leads to a finite informed component of size m"; h2(x) is defined analogously for type-2 links. Finally, we let H(x) define the generating function for the finite number of nodes that receive an information started from an arbitrary node. 10 We start by deriving the recursive relations governing h1(x) and h2(x). We find that the generating functions h1(x) and h2(x) satisfy the self-consistency equations h1(x) = xXd h2(x) = xXd Tf h1(x)df −1h2(x)dw + (1 − Tf ) (23) Twh1(x)df h2(x)dw −1 + (1 − Tw) (24) dwpd < dw > < df > df pd The validity of (23) can be seen as follows: The explicit factor x accounts for the initial vertex that is arrived at. The factor df pd/ < df > gives [20] the normalized probability that an edge of type 1 is attached (at the other end) to a vertex with colored degree d = (df , dw). Since the arrived node is reached by a type-1 link, it will receive the information with probability Tf . If the arrived node receives the information, it will be added to the component of informed nodes and it can inform other nodes via its remaining df − 1 links of type-1 and dw links of type-2. Since the number of nodes reached and informed by each of its type-1 (resp. type- 2) links is generated in turn by h1(x) (resp. h2(x)) we obtain the term h1(x)df −1h2(x)dw by the powers property of generating functions [31], [20]. Averaging over all possible colored degrees d gives the first term in (23). The second term with the factor x0 = 1 accounts for the possibility that the arrived node does not receive the information and thus is not included in the cluster of informed nodes. The relation (24) can be validated via similar arguments. Using the relations (23)-(24), we now find the finite num- ber of nodes reached and informed by the above branching process. We have that H(x) = xXd pdh1(x)df h2(x)dw . (25) Similar to (23)-(24), the relation (25) can be seen as follows: The factor x corresponds to the initial node that is selected arbitrarily and given a piece of information. The selected node has colored degree d = (df , dw) with probability pd. The number of nodes it reaches and informs via each of its df (resp. dw) links of type 1 (resp. type 2) is generated by h1(x) (resp. h2(x)). This yields the term h1(x)df h2(x)dw and averaging over all possible colored degrees, we get (25). We are interested in the solution of the recursive relations (23)-(24) for the case x = 1. This case exhibits a trivial fixed point h1(1) = h2(1) = 1 which yields H(1) = 1 meaning that the underlying branching process is in the subcritical regime and that all informed components have finite size as understood from the conservation of probability. However, the fixed point h1(1) = h2(1) = 1 corresponds to the physical solution only if it i.e., a stable solution to the recursion (23)-(24). The stability of this fixed point can be checked via linearization of (23)-(24) around h1(1) = h2(1) = 1, which yields the Jacobian matrix J given by J (i, j) = ∂hi(1) for i, j = 1, 2. This gives is an attractor; Tf <df dw> <df > Tw<(d2 w−dw)> <dw> .   (26) ∂hj (1)(cid:12)(cid:12)h1(1)=h2(1)=1 J =   Tw<dwdf > f −df )> <dw> Tf <(d2 <df > k }, Tw, {pf If all the eigenvalues of J are less than one in absolute value (i.e., if the spectral radius σ(J ) of J satisfies σ(J ) ≤ 1), then the solution h1(1) = h2(1) = 1 is an attractor and H(1) = 1 becomes the physical solution, meaning that k}, Tf ) does not possess a giant compo- H(n; α, {pw nent whp. In that case, the fraction of nodes that receive the information tends to zero in the limit n → ∞. On the other hand, if the spectral radius of J is larger than one, then the fixed point h1(1) = h2(1) = 1 is unstable pointing out that the asymptotic branching process is supercritical, with a positive probability of producing infinite trees. In that case, a nontrivial fixed point exists and becomes the attractor of the recursions (23)-(24), yielding a solution with h1(1), h2(1) < 1. In view of (25) this implies H(1) < 1 and the corresponding probability deficit 1 − H(1) is attributed to the existence of a giant (infinite) component of informed nodes. In fact, the quantity 1 − H(1) is equal to the probability that a randomly chosen vertex belongs to the giant component, which contains asymptotically a fraction 1 − H(1) of the vertices. Collecting these Theorem 3.1 is now within easy reach. First, recall that kf and kw are random variables independently drawn from the distributions {pf k }, respectively, so that df is a random variable that is statistically equivalent to kf with probability α, and equal to zero otherwise. On the st= dw. Using (4) in (26), we now get other hand, we have kw Twαλf Twβw (cid:21) J = (cid:20) Tf βf k} and {pw Tf λw by the independence of df and dw. It is now a simple matter f w is as defined in (5). to see that σ(J ) = σ⋆ Therefore, we have established that the epidemic threshold is given by σ⋆ f w = 1, and part (i) of Theorem 3.1 follows. f w, where σ⋆ Next, we set x = 1 in the recursive relations (23)-(24) and let h1 := h1(1) and h2 := h2(1). Using (3) and elementary algebra, we find that the stable solution of the recursions (23)- (24) is given by the smallest solution of (6)-(7) with h1, h2 in (0, 1]. It is also easy to check from (25) that H(1) = Ehαhkf 2 i , 1 + 1 − αi × Ehhkw and part (ii) of Theorem 3.1 follows upon recalling that the fractional size of the giant component (i.e., the number of informed nodes) is given by 1 − H(1) whp. We now turn to proving Theorem 3.2. In the subcritical regime, H(x) corresponds to generating function for the distribution of outbreak sizes; i.e, distribution of the number of nodes that receive an information started from an arbitrary node. Therefore, the mean outbreak size is given by the first derivative of H(x) at the point x = 1. Namely, we have < s >= := H ′(1). (27) dH(x) dx (cid:12)(cid:12)(cid:12)x=1 Recalling that h1(1) = h2(1) = 1 in the subcritical regime, we get from (25) that H ′(1) = 1 + h′ 1(1)Xd pddf + h′ 2(1)Xd pddw = 1 + αλf h′ 1(1) + λwh′ 2(1). (28) 11 The derivatives h′ 2(1) can also be computed recursively using the relations (23)-(24). In fact, it is easy to check that 1(1) and h′ h′ 1(1) = Tf + Tf βf h′ h′ 2(1) = Tw + Twαλf h′ 1(1) + Tf λwh′ 2(1) 1(1) + Twβwh′ 2(1) (29) (30) upon using (4) and other definitions introduced previously. Now, setting s1 := h′ 2(1), we obtain (11)-(12) from (29)-(30), and Theorem 3.2 follows upon substituting (28) into (27). 1(1) and s2 := h′ VII. PROOF OF THEOREM 3.3 In this section, we give a proof Theorem 3.3. First, we summarize the technical tools that will be used. A. Inhomogeneous Random Graphs Recently, Bollobas, Janson and Riordan [38] have devel- oped a new theory of inhomogeneous random graphs that would allow studying phase transition properties of complex networks in a rigorous fashion. The authors in [38] established very general results for various properties of these models, including the critical point of their phase transition, as well as the size of their giant component. Here, we summarize these tools with focus on the results used in this paper. At the outset, assume that a graph is defined on vertices {1, . . . , n}, where each vertex i is assigned randomly or deterministically a point xi in a metric space S. Assume that the metric space S is equipped with a Borel probability measure µ such that for any µ-continuity set A ⊆ S (see [38]) 1 n · n Xi=1 1 [xi ∈ A] p −→ µ(A). (31) space V A vertex triple (S, µ, {x1, . . . , xn}) where {x1, . . . , xn} is a sequence of points in S satisfying (31). defined then as is a Next, let a kernel κ on the space (S, µ) define a symmetric, non-negative, measurable function on S×S. The random graph GV (n, κ) on the vertices {1, . . . , n} is then constructed by assigning an edge between i and j (i < j) with probability κ(xi, xj)/n, independently of all the other edges in the graph. Consider random graphs GV (n, κ) for which the kernel κ is bounded and continuous a.e. on S × S. In fact, in this study it suffices to consider only the cases where the metric space S consists of finitely many points, i.e., S = {1, . . . , r}. Under these assumptions, the kernel κ reduces to an r×r matrix, and GV (n, κ) becomes a random graph with vertices of r different types; e.g., vertices with/without Facebook membership, etc. Two nodes (in GV (n, κ)) of type i and j are joined by an edge with probability n−1κ(i, j) and the condition (31) reduces to ni n p −→ µi, i = 1, . . . , r, (32) where ni stands for the number of nodes of type i and µi is equal to µ({i}). As usual, the phase transition properties of GV (n, κ) can be studied by exploiting the connection between the component structure of the graph and the survival probability of a related branching process. In particular, consider a branching process that starts with an arbitrary vertex and recursively reveals the largest component reached by exploring its neighbors. For each i = 1, . . . , r, we let ρ(κ; i) denote the probability that the branching process produces infinite trees when it starts with a node of type i. The survival probability ρ(κ) of the branching process is then given by ρ(κ) = r Xi=1 ρ(κ; i)µi. (33) In analogy with the classical results for ER graphs [33], it is shown [38] that ρ(κ; i)'s satisfy the recursive equations ρ(κ; i) = 1 − exp  − r Xj=1 κ(i, j)µj · ρ(κ; j)  , i = 1, . . . , r. (34) The value of ρ(κ) can be computed via (33) by characterizing the stable fixed point of (34) reached from the starting point ρ(κ; 1) = · · · = ρ(κ; r) = 0. It is a simple matter to check that, with M denoting an r × r matrix given by M (i, j) = κ(i, j) · µj, the iterated map (34) has a non-trivial solution (i.e., a solution other than ρ(κ; 1) = · · · = ρ(κ; r) = 0) iff σ(M ) := max{λi : λi is an eigenvalue of M } > 1. (35) Thus, we see that if the spectral radius of M is less than or equal to one, the branching process is subcritical with ρ(κ) = 0 and the graph GV (n, κ) has no giant component; i.e., we have that C1(GV (n, κ)) = o(n) whp. On the other hand, if σ(M ) > 1, then the branching process is supercritical and there is a non-trivial solution ρ(κ; i) > 0, i = 1, . . . , r that corresponds to a stable fixed point of (34). In that case, ρ(κ) > 0 corresponds to the probability that an arbitrary node belongs to the giant component, which asymptotically contains a fraction ρ(κ) of the vertices. In other words, if σ(M ) > 1, we have that C1(GV (n, κ)) = Ω(n) whp, and 1 p −→ ρ(κ). n C1(GV (n, κ)) Bollobas et al. [38, Theorem 3.12] have shown that the bound C1(GV (n, κ)) = o(n) in the subcritical case can be improved under some additional conditions: They established that whenever supi,j κ(i, j) < ∞ and σ(M ) ≤ 1, then we have C1(GV (n, κ)) = O(log n) whp as in the case of ER graphs. They have also shown that if either supi,j κ(i, j) < ∞ or inf i,j κ(i, j) > 0, then in the supercritical regime (i.e., when σ(M ) > 1) the second largest component satisfies C2(GV (n, κ)) = O(log n) whp. B. A Proof of Theorem 3.3 We start by studying the information spread over the net- work H when information transmissibilities Tw and Tf are both equal to 1. Clearly, this corresponds to studying the phase transition in H = H(n; α, λw, λf ), and we will do so by using the techniques summarized in the previous section. Let S = {1, 2} stand for the space of vertex types, where vertices with Facebook membership are referred to as type 1 while vertices without Facebook membership are said to be of type 2; notice that this is different than the case in the proof 12 of Theorem 3.1 where we distinguish between different link types. In other words, we let xi = (cid:26) 1 2 if i ∈ NF if i 6∈ NF for each i = 1, . . . , n. Assume that the metric space S is equipped with a probability measure µ that satisfies the condi- tion (32); i.e., µ({1}) := µ1 = α and µ({2}) := µ2 = 1 − α. Finally, we compute the appropriate kernel κ such that, for each i, j = {1, 2}, κ(i, j)/n gives the probability that two vertices of type i and j are connected. Clearly, we have α − λwλf αn , κ(1, 1) = n(cid:16)1 −(cid:0)1 − λw αn(cid:17)(cid:17) = λw + λf whereas κ(1, 2) = κ(2, 1) = κ(2, 2) = λw. n (cid:1)(cid:16)1 − λf We are now in a position to derive the critical point of the phase transition in H(n; α, λw, λf ) as well as the giant component size C1(H(n; α, λw, λf )). First, we compute the matrix M (i, j) = κ(i, j)µj and get M = (cid:20) αλw + λf − λw λf αλw n (1 − α)λw (1 − α)λw (cid:21) . It is clear that the term λwλf has no effect on the results as n we eventually let n go to infinity. It is now a simple matter to check that the spectral radius of M is given by σ(M ) = 1 2 (cid:18)λf + λw +q(λf + λw)2 − 4(1 − α)λf λw(cid:19) This leads to the conclusion that the random graph H(n; α, λw, λf ) has a giant component if and only if 1 2 (cid:18)λf + λw +q(λf + λw)2 − 4(1 − α)λf λw(cid:19) > 1 (36) as we recall (35). If condition (36) is not satisfied, then we have C1(H(n; α, λw, λf )) = O(log n) as we note that supi,j κ(i, j) < ∞. From [38, Theorem 3.12], we also get that C2(H(n; α, λw, λf )) = O(log n) whenever (36) is satisfied. Next, we compute the size of the giant component whenever it exists. Let ρ(κ; 1) = ρ1 and ρ(κ; 2) = ρ2. In view of (33) and the arguments presented previously, the asymptotic fraction of nodes in the giant component is given by ρ(κ) = αρ1 + (1 − α)ρ2, (37) where ρ1 and ρ2 constitute a stable simultaneous solution of the transcendental equations ρ1 = 1 − exp {−ρ1(αλw + λf ) − ρ2(1 − α)λw} ρ2 = 1 − exp {−ρ1αλw − ρ2(1 − α)λw} (38) So far, we have established the epidemic threshold and the size of the information epidemic when Tw = Tf = 1. In the more general case where there is no constraint on the transmissibilities, we see that the online social network F becomes an ER graph with average degree Tf λf , whereas the physical network W becomes an ER graph with average degree Twλw. Therefore, the critical threshold and the size of the information epidemic can be found by substituting Tf λf for λf and Twλw for λw in the relations (36), (37) and (38). This establishes Theorem 3.3. VIII. CONCLUSION In this paper, we characterized the critical threshold and the asymptotic size of information epidemics in an overlaying social-physical network. To capture the spread of information, we considered a physical information network that character- izes the face-to-face interactions of human beings, and some overlaying online social networks (e.g., Facebook, Twitter, etc.) that are defined on a subset of the population. Assuming that information is transmitted between individuals according to the SIR model, we showed that the critical point and the size of information epidemics on this overlaying social-physical network can be precisely determined. To the best of our knowledge, this study marks the first work on the phase transition properties of conjoint networks where the vertex sets are neither identical (as in [3], [25]) nor disjoint (as in [27]). We believe that our findings here shed light on the further studies on information (and influence) propagation across social-physical networks. REFERENCES [1] CPS Steering Group, "Cyber-physical systems executive summary," 2008. [2] S. V. Buldyrev, R. Parshani, G. Paul, H. E. Stanley, and S. Havlin, "Catastrophic cascade of failures in interdependent networks," Nature, vol. 464, pp. 1025 -- 1028, 2010. [3] W. Cho, K. I. Goh, and I. M. Kim, "Correlated couplings and robustness of coupled networks," arXiv:1010.4971v1 [physics.data-an], 2010. [4] R. Cohen and S. Havlin, Complex Networks: Structure, Robustness and Function. United Kingdom: Cambridge University Press, 2010. [5] A. Vespignani, "Complex networks: The fragility of interdependency," Nature, vol. 464, pp. 984 -- 985, 2010. [6] O. Yagan, D. Qian, J. Zhang, and D. Cochran, "Optimal Allocation of Interconnecting Links in Cyber-Physical Systems: Interdependence, Cascading Failures and Robustness," IEEE Transactions on Parallel and Distributed Systems, vol. 23, no. 9, pp. 1708 -- 1720, 2012. [7] R. L. Hotz, "Decoding our chatter," Wall Street Journal, 1 October 2011. [8] K. Lerman and R. Ghosh, "Information contagion: An empirical study of the spread of news on digg and twitter social networks," in Proceedings of 4th International Conference on Weblogs and Social Media (ICWSM), 2010. [9] H. Kim and E. Yoneki, "Influential neighbours selection for information diffusion in online social networks," in Proceedings of IEEE Inter- national Conference on Computer Communication Networks (ICCCN), (Munich, Germany), July 2012. [10] D. Wang, Z. Wen, H. Tong, C.-Y. Lin, C. Song, and A.-L. Barab´asi, "Information spreading in context," in Proceedings of the 20th inter- national conference on World wide web, WWW '11, (New York, NY, USA), pp. 735 -- 744, 2011. [11] E. Bakshy, I. Rosenn, C. Marlow, and L. Adamic, "The role of social networks in information diffusion," in Proceedings of ACM WWW, (Lyon, France), April 2012. [12] D. Liben-Nowell and J. Kleinberg, "Tracing information flow on a global scale using Internet chain-letter data," Proceedings of the National Academy of Sciences, vol. 105, pp. 4633 -- 4638, Mar. 2008. [13] J. Leskovec, M. McGlohon, C. Faloutsos, N. S. Glance, and M. Hurst, "Patterns of cascading behavior in large blog graphs," in Proceedings of the Seventh SIAM International Conference on Data Mining, April 26-28, 2007, Minneapolis, Minnesota, USA, 2007. [14] R. M. Anderson and R. M. May, Infectious Diseases of Humans. Oxford (UK): Oxford University Press, 1991. [15] N. T. J. Bailey, The Mathematical Theory of Infectious Diseases and its Applications. New York (NY): Hafner Press, 1975. [16] H. W. Hethcote, "Mathematics of infectious diseases," SIAM Review, vol. 42, no. 4, pp. 599 -- 653, 2000. [17] M. Kuperman and G. Abramson, "Small world effect in an epidemio- logical model," Phys. Rev. Lett., vol. 86, no. 13, pp. 2909 -- 2912, 2001. [18] C. Moore and M. E. J. Newman, "Epidemics and percolation in small- world networks," Phys. Rev. E, vol. 61, no. 5, pp. 5678 -- 5682, 2000. 13 [19] R. Pastor-Satorras and A. Vespignani, "Epidemic spreading in scale-free networks," Phys. Rev. Lett., vol. 86, pp. 3200 -- 3203, 2001. [20] M. E. J. Newman, "Spread of epidemic disease on networks," Phys. Rev. E, vol. 66, no. 1, 2002. [21] D. Gruhl, R. Guha, D. Liben-Nowell, and A. Tomkins, "Information diffusion through blogspace," in Proceedings of the 13th international conference on World Wide Web, WWW '04, (New York, NY, USA), pp. 491 -- 501, ACM, 2004. [22] X. Sun, Y.-H. Liu, B. Li, J. Li, J.-W. Han, and X.-J. Liu, "Mathematical model for spreading dynamics of social network worms," Journal of Statistical Mechanics: Theory and Experiment, vol. 2012, no. 04, p. P04009, 2012. [23] K. Leibnitz, T. Hossfeld, N. Wakamiya, and M. Murata, "On pollution in edonkey-like peer-to-peer file-sharing networks," Measuring, Modelling and Evaluation of Computer and Communication Systems (MMB), 2006 13th GI/ITG Conference, pp. 1 -- 18, march 2006. [24] M. Ostilli, E. Yoneki, I. X. Y. Leung, J. F. F. Mendes, P. Li`o, and J. Crowcroft, "Statistical mechanics of rumour spreading in network communities," Procedia CS, vol. 1, no. 1, pp. 2331 -- 2339, 2010. [25] M. Kurant and P. Thiran, "Layered complex networks," Phys. Rev. Lett., vol. 96, no. 13, 2006. [26] V. Marceau, P.-A. Noel, L. H´ebert-Dufresne, A. Allard, and L. J. Dub´e, interaction between epidemics on overlay "Modeling the dynamical networks," Physical Review E, vol. 84, no. 2, 2011. [27] E. A. Leicht and R. M. D'Souza, "Percolation on interacting networks," arXiv:0907.0894v1 [cond-mat.dis-nn], 2009. [28] A. Saumell-Mendiola, M. ´A. Serrano, and M. Bogun´a, "Epidemic spreading on interconnected networks," arXiv:1202.4087, 2012. [29] J. M. Epstein, "Why model?," Journal of Artificial Societies and Social Simulation, vol. 11, no. 4, p. 12, 2008. [30] J. Kleinberg, Cascading Behavior in Networks: Algorithmic and Eco- nomic Issues, ch. 24. Cambridge University Press, 2007. [31] M. E. J. Newman, S. H. Strogatz, and D. J. Watts, "Random graphs with arbitrary degree distributions and their applications," Phys. Rev. E, vol. 64, no. 2, 2001. [32] S. R. Broadbent and J. M. Hammersley, "Percolation processes," Math- ematical Proceedings of the Cambridge Philosophical Society, vol. 53, pp. 629 -- 641, 1957. [33] B. Bollob´as, Random Graphs. Cambridge (UK): Cambridge Studies in Advanced Mathematics, Cambridge University Press, 2001. [34] A. Clauset, C. R. Shalizi, and M. E. J. Newman, "Power-law distribu- tions in empirical data," SIAM Rev., vol. 51, pp. 661 -- 703, Nov. 2009. [35] M. Molloy and B. Reed, "A critical point for random graphs with a given degree sequence," Random Structures and Algorithms, vol. 6, pp. 161 -- 179, 1995. [36] B. Soderberg, "Random graphs with hidden color," Phys. Rev. E, vol. 68, no. 015102(R), 2003. [37] P. Grassberger, "On the critical behavior of the general epidemic process and dynamical percolation," Mathematical Biosciences, vol. 63, no. 2, pp. 157 -- 172, 1983. [38] B. Bollob´as, S. Janson, and O. Riordan, "The phase transition in inhomogeneous random graphs," Random Structures and Algorithms, vol. 33, no. 1, pp. 3 -- 122, 2007. [39] B. Soderberg, "Properties of random graphs with hidden color," Phys. Rev. E, vol. 68, no. 2, pp. 026107 -- , 2003. APPENDIX INFORMATION DIFFUSION WITH MULTIPLE ONLINE SOCIAL NETWORKS So far, we have assumed that information diffuses amongst human beings via only a physical information network W and an online social network F. To be more general, one can extend this model to the case where there are multiple online social networks. For instance assume that there is an additional online social network, say Twitter, denoted by T(n; αt) whose members are selected by picking each node 1, . . . , n independently with probability αt. In other words, with NT denoting the set vertices of T, we have P [i ∈ NT ] = αt, i = 1, . . . , n. 14 The fractional size of the giant component (i.e., information epidemic) can also be found. Recalling (33) and (34), we see that 1 n C1 (H(n; αf , αt, λw, λf , λt)) p −→ αf αtρ1 + αf (1 − αt)ρ2 + (1 − αf )αtρ3 + (1 − αf )(1 − αt)ρ4, (A.2) where 0 ≤ ρ1, ρ2, ρ3, ρ4 ≤ 1 are given by the largest solution to the recursive relations , i = 1, 2, 3, 4. (A.3) ρi = 1 − exp  − 4 Xj=1 M (i, j)ρj  In the case where there is no constraint on the transmissi- bilities Tw, Tf and Tt, the conclusions (A.1), (A.2) and (A.3) still apply if we substitute Twλw for λw, Tf λf for λf and Ttλt for λt. To be consistent with this notation, we assume that the members of the online social network F (i.e., Facebook) are selected by picking each node 1, . . . , n independently with probability αf . n , λf αf n , and λt The overlaying social-physical network now consists of a network formed by conjoining W, F and T; i.e., we have H = W ∪ F ∪ T. To demonstrate the applicability of the techniques for this general set-up, we now consider a simple example where W, F and T are all ER graphs with edge probabilities given by λw αtn , respectively. This yields an asymptotic mean degree of λw, λf and λt, in the networks W, F and T, respectively. For the time being, assume that the transmissibilities Tw, Tf and Tt are all equal to one. Now, recall the concept of inhomogeneous random graphs presented in Section VII-A. Let S = {1, 2, 3, 4} stand for the space of vertex types, where vertices with Facebook and Twitter membership are referred to as type 1, vertices with Facebook membership but without Twitter membership are referred to as type 2, vertices with Twitter membership but without Facebook membership are referred to as type 3, and finally vertices with neither Facebook nor Twitter membership are said to be of type 4. That is, we set 1 2 3 4 if i ∈ NF and i ∈ NT if i ∈ NF and i 6∈ NT if i 6∈ NF and i ∈ NT if i 6∈ NF and i 6∈ NT xi =   for each i = 1, . . . , n. Assume that the metric space S is equipped with a probability measure µ that satisfies condition (32); i.e., µ1 = αf αt, µ2 = αf (1 − αt), µ3 = (1 − αf )αt, and µ4 = (1 − αf )(1 − αt). The next step is to compute the appropriate kernel κ such that, for each i, j = {1, 2, 3, 4}, κ(i, j)/n gives the probability that two vertices of type i and j are connected. For n large, it is not difficult to see that we have κ = + λt αt   λw + λt αt λw + λf αf λw + λf αf λw + λf αf λw + λf αf λw + λt αt λw λw λw λw λw The matrix M (i, j) = κ(i, j)µj is now given by λw + λt αt λw λw λw λw   M =   λwαf αt + λf αt + λtαf λwαf αt + λf αt λwαf αt + λf αt λwαf αt + λf αt λwαf αt + λtαf λwαf αt λwαf αt λwαf αt λwαf αt + λtαf λwαf αt λwαf αt λwαf αt λwαf αt + λf αt λwαf αt λwαf αt λwαf αt   (A.1) and the critical point of the phase transition as well as the giant component size of H(n; αf , αt, λw, λf , λt) can now be obtained by using the arguments of Section VII-A. An item of information originating from a single node in H = W ∪ F ∪ T can reach a positive fraction of the individuals only if the spectral radius of M is greater than unity. If it is the case that σ(M ) ≤ 1, then there is no information epidemic and all information outbreaks have size O(log n).
1811.10915
1
1811
2018-11-27T11:21:09
Robust active attacks on social graphs
[ "cs.SI" ]
In order to prevent the disclosure of privacy-sensitive data, such as names and relations between users, social network graphs have to be anonymised before publication. Naive anonymisation of social network graphs often consists in deleting all identifying information of the users, while maintaining the original graph structure. Various types of attacks on naively anonymised graphs have been developed. Active attacks form a special type of such privacy attacks, in which the adversary enrols a number of fake users, often called sybils, to the social network, allowing the adversary to create unique structural patterns later used to re-identify the sybil nodes and other users after anonymisation. Several studies have shown that adding a small amount of noise to the published graph already suffices to mitigate such active attacks. Consequently, active attacks have been dubbed a negligible threat to privacy-preserving social graph publication. In this paper, we argue that these studies unveil shortcomings of specific attacks, rather than inherent problems of active attacks as a general strategy. In order to support this claim, we develop the notion of a robust active attack, which is an active attack that is resilient to small perturbations of the social network graph. We formulate the design of robust active attacks as an optimisation problem and we give definitions of robustness for different stages of the active attack strategy. Moreover, we introduce various heuristics to achieve these notions of robustness and experimentally show that the new robust attacks are considerably more resilient than the original ones, while remaining at the same level of feasibility.
cs.SI
cs
Robust active attacks on social graphs Sjouke Mauw1,2, Yunior Ram´ırez-Cruz2 and Rolando Trujillo-Rasua3 1CSC, 2SnT, University of Luxembourg 6, av. de la Fonte, L-4364 Esch-sur-Alzette, Luxembourg 3School of Information Technology, Deakin University 221 Burwood Hwy., Burwood VIC 3125, Australia {sjouke.mauw, yunior.ramirez}@uni.lu, [email protected] November 28, 2018 Abstract In order to prevent the disclosure of privacy-sensitive data, such as names and relations between users, social network graphs have to be anonymised before publi- cation. Naive anonymisation of social network graphs often consists in deleting all identifying information of the users, while maintaining the original graph structure. Various types of attacks on naively anonymised graphs have been developed. Active attacks form a special type of such privacy attacks, in which the adversary enrols a number of fake users, often called sybils, to the social network, allowing the adversary to create unique structural patterns later used to re-identify the sybil nodes and other users after anonymisation. Several studies have shown that adding a small amount of noise to the published graph already suffices to mitigate such active attacks. Con- sequently, active attacks have been dubbed a negligible threat to privacy-preserving social graph publication. In this paper, we argue that these studies unveil shortcom- ings of specific attacks, rather than inherent problems of active attacks as a general strategy. In order to support this claim, we develop the notion of a robust active attack, which is an active attack that is resilient to small perturbations of the social network graph. We formulate the design of robust active attacks as an optimisation problem and we give definitions of robustness for different stages of the active attack strategy. Moreover, we introduce various heuristics to achieve these notions of ro- bustness and experimentally show that the new robust attacks are considerably more resilient than the original ones, while remaining at the same level of feasibility. Keywords: privacy-preserving social graph publication, active attacks 1 Introduction Data is useful. Science heavily relies on data to (in)validate hypotheses, discover new trends, tune up mathematical and computational models, etc. In other words, data col- 1 lection and analysis is helping to cure diseases, build more efficient and environmentally- friendly buildings, take socially-responsible decisions, understand our needs and those of the planet where we live. Despite these indisputable benefits, it is also a fact that data contains personal and potentially sensitive information, and this is where privacy and use- fulness should be considered as a whole. A massive source of personal information is currently being handled by online social networks. People's life is often transparently reflected on popular social network platforms, such as Facebook, Twitter and Youtube. Therefore, releasing social network data for fur- ther study comes with a commitment to ensure that users remain anonymous. Anonymity, however, is remarkably hard to achieve. Even a simple social graph, where an account consists of a user's pseudonym only and its relation to other accounts, allows users to be re-identified by just considering the number of relations they have [13]. The use of pseudonyms is insufficient to guarantee anonymity. An attacker can cross- reference information from other sources, such as the number of connections, to find out the real user behind a pseudonym. Taking into account the type of information an attacker may have, called background or prior knowledge, is thus a common practice in anonymi- sation models. In a social graph, the adversary's background knowledge is regarded as any subgraph that is isomorphic to a subgraph in the original social graph. Various works bound the adversary's background knowledge to a specific family of graphs. For example, Liu and Terzi assume that the adversary's background knowledge is fully defined by star graphs1 [13]. This models an adversary that knows the degrees of the victim vertices. Others assume that an adversary may know the subgraphs induced by the neighbours of their victims [37], and so on [38]. A rather different notion of background knowledge was introduced by Backstrom et al. [1]. They describe an adversary able to register several (fake) accounts to the network, called sybil accounts. The sybil accounts establish links between themselves and also with the victims. Therefore, in Backstrom et al.'s attack to a social graph G = (V, E), the adversary's background knowledge is the induced subgraph formed by the sybil accounts in G joined with the connections to the victims. The adversary introduced by Backstrom et al. [1] is said to be active, because he influences the structure of the social network. Previous authors have claimed that active attacks are either unfeasible or detectable. Such a claim is based on two observations. First, inserting many sybil nodes is hard, and they may be detected and removed by sybil detection techniques [21]. Second, active attacks have been reported to suffer from low resilience, in the sense that the attacker's ability to successfully recover the sybil subgraph and re-identify the victims is easily lost after a relatively small number of (even arbitrary) changes are introduced in the network [11, 17, 18, 19]. As a consequence, active attacks have been largely overlooked in literature. Backstrom et al. argue for the feasibility of active attacks, showing that proportionally few sybil nodes (in the order of log n nodes for networks of order n) are sufficient for compromising any legitimate node. This feature of active attacks is relevant in view of the fact that sybil defence mechanisms do not attempt 1A star graph is a tree of depth one. 2 to remove every sybil node, but to limit their number to no more than log n [35, 34], which entails that sufficiently capable sybil subgraphs are likely to go unnoticed by sybil defences. The second claim, that of lack of resiliency to noisy releases, is the main focus of this work. Contributions. In this paper we show that active attacks do constitute a serious threat for privacy-preserving publication of social graphs. We do so by proposing the first active attack strategy that features two key properties. Firstly, it can effectively re-identify users with a small number of sybil accounts. Secondly, it is resilient, in the sense that it resists not only the introduction of reasonable amounts of noise in the network, but also the application of anonymisation algorithms specifically designed to counteract active attacks. The new attack strategy is based on new notions of robustness for the sybil subgraph and the set of fingerprints, as well as noise-tolerant algorithms for sybil subgraph retrieval and re-identification. The comparison of the robust active attack strategy to the original active attack is facilitated by the introduction of a novel framework of study, which views an active attack as an attacker-defender game. The remainder of this paper is structured as follows. We enunciate our adversarial model in the form of an attacker-defender game in Section 2. Then, the new notions of robustness are introduced in Section 3, and their implementation is discussed in Section 4. Finally, we experimentally evaluate our proposal in Section 5, discuss related work in Section 6, and give our conclusions in Section 7. 2 Adversarial model We design a game between an attacker A and a defender D. The goal of the attacker is to identify the victim nodes after pseudonymisation and transformation of the graph by the defender. We first introduce the necessary graph theoretical notation, and then formulate the three stages of the attacker-defender game. 2.1 Notation and terminology We use the following standard notation and terminology. Additional notation that may be needed in other sections of the paper will be introduced as needed. • A graph G is represented as a pair (V, E), where V is a set of vertices (also called nodes) and E ⊆ V × V is a set of edges. The vertices of G are denoted by VG and its edges by EG. As we will only consider undirected graphs, we will consider an edge (v, w) as an unordered pair. We will use the notation G for the set of all graphs. • An isomorphism between two graphs G = (V, E) and G(cid:48) = (V (cid:48), E(cid:48)) is a bijective function ϕ : V → V (cid:48), such that ∀v1,v2∈V .(v1, v2) ∈ E ⇐⇒ (ϕ(v1), ϕ(v2)) ∈ E(cid:48). Two graphs are isomorphic, denoted by G (cid:39)ϕ G(cid:48), or briefly G (cid:39) G(cid:48), if there exists an isomorphism ϕ between them. Given a subset of vertices S ⊆ V , we will often use ϕS to denote the set {ϕ(v)v ∈ S}. 3 • The set of neighbours of a set of nodes W ⊆ V is defined by NG(W ) = {v ∈ V \ W If W = {w} is a singleton set, we will write ∃w∈W .(v, w) ∈ E ∨ (w, v) ∈ E}. NG(w) for NG({w}). The degree of a vertex v ∈ V , denoted as δG(v), is defined as δG(v) = NG(v). • Let G = (V, E) be a graph and let S ⊆ V . The weakly-induced subgraph of S G, is the subgraph of G with vertices S ∪ NG(S) and edges in G, denoted by (cid:104)S(cid:105)w {(v, v(cid:48)) ∈ E v ∈ S ∨ v(cid:48) ∈ S}). 2.2 The attacker-defender game The attacker-defender game starts with a graph G = (V, E) representing a snapshot of a social network. The attacker knows a subset of the users, but not the connections between them. An example is shown in Figure 1(a), where capital letters represent the real identities of the users and dotted lines represent the relations existing between them, which are not known to the adversary. Before a pseudonymised graph is released, the attacker manages to enrol sybil accounts in the network and establish links with the victims, as depicted in Figure 1(b), where sybil accounts are represented by dark-coloured nodes and the edges known to the adversary (because they were created by her) are represented by solid lines. The goal of the attacker is to later re-identify the victims in order to learn information about them. The defender anonymises the social graph by removing the real user identities, or replacing them with pseudonyms, and possibly perturbing the graph. In Figure 1(c) we illustrate the pseudonymisation process of the graph in Figure 1(b). The pseudonymised graph contains information that the attacker wishes to know, such as the existence of relations between users, but the adversary cannot directly learn this information, as the identities of the vertices are hidden. Thus, after the pseudonymised graph is published, the attacker analyses the graph to first re-identify its own sybil accounts, and then the victims (see Figure 1(d)). This allows her to acquire new information, which was supposed to remain private, such as the fact that E and F are friends. Next, we formalise the three stages of the attacker-defender game, assuming a graph G = (V, E). 1. Attacker subgraph creation. The attacker constructs a set of sybil nodes S = {x1, x2, . . . , xS}, such that S ∩ V = ∅ and a set of edges F ⊆ (S × S)∪ (S × V )∪ (V × S). It clearly follows that E ∩ F = ∅. We call G+ = (V ∪ S, E ∪ F ) the sybil-extended graph of G. The attacker does not know the complete graph G+, but he knows (cid:104)S(cid:105)w G+, the weakly-induced subgraph of S in G+. We say that (cid:104)S(cid:105)w G+ is the attacker subgraph. The attacker subgraph creation has two substages: (a) Creation of inter-sybil connections. A unique (with high probability) and effi- ciently retrievable connection pattern is created between sybil nodes to facilitate the attacker's task of retrieving the sybil subgraph at the final stage. (b) Fingerprint creation. For a given victim vertex y ∈ NG+(S) \ S, we call the victim's neighbours in S, i.e NG+(y) ∩ S, its fingerprint. Considering the set 4 (a) A fragment of the orig- inal graph. (b) The sybil nodes are added and fin- gerprints are created for the victims. (c) Pseudonymised graph after release. (d) The attacker subgraph is recov- ered and the victims are re-identified. Figure 1: The attacker-defender game. of victim vertices Y = {y1, . . . , ym}, the attacker ensures that NG+(yi) ∩ S (cid:54)= NG+(yj) ∩ S for every yi, yj ∈ Y , i (cid:54)= j. 2. Anonymisation. The defender obtains G+ and constructs an isomorphism ϕ from G+ to ϕG+. We call ϕG+ the pseudonymised graph. The purpose of pseudonymisation is to remove all personally identifiable information from the vertices of G. Next, given a non-deterministic procedure t that maps graphs to graphs, known by both A and D, the defender applies transformation t to ϕG+, resulting in the transformed graph t(ϕG+). The procedure t modifies ϕG+ by adding and/or removing vertices and/or edges. 3. Re-identification. After obtaining t(ϕG+), the attacker executes the re-identification attack in two stages. (a) Attacker subgraph retrieval. Determine the isomorphism ϕ restricted to the domain of sybil nodes S. (b) Fingerprint matching. Determine the isomorphism ϕ restricted to the domain of victim nodes {y1, y2, . . . , ym}. 5 EFDABCEFDABC321z3z7z2z4z8z6z9z5z1EFz2z4z8z6321 As established by the last step of the attacker-defender game, we consider the adversary to succeed if she effectively determines the isomorphism ϕ restricted to the domain of victim nodes {y1, y2, . . . , ym}. That is, when the adversary re-identifies all victims in the anonymised graph. 3 Robust active attacks This section formalises robust active attacks. We provide mathematical formulations, in the form of optimisation problems, of the attacker's goals in the first and third stages. In particular, we address three of the subtasks that need to be accomplished in these stages: fingerprint creation, attacker subgraph retrieval and fingerprint matching. 3.1 Robust fingerprint creation Active attacks, in their original formulation [1], aimed at re-identifying victims in pseudo- nymised graphs. Consequently, the uniqueness of every fingerprint was sufficient to guaran- tee success with high probability, provided that the attacker subgraph is correctly retrieved. Moreover, as shown in [1], several types of randomly generated attacker subgraphs can in- deed be correctly and efficiently retrieved, with high probability, after pseudonymisation. The low resilience reported for this approach when the pseudonymised graph is perturbed by applying an anonymisation method [17, 18, 19] or by introducing arbitrary changes [11], comes from the fact that it relies on finding exact matches between the fingerprints created by the attacker at the first stage of the attack and their images in t(ϕG+). The attacker's ability to find such exact matches is lost even after a relatively small number of perturbations is introduced by t. Our observation is that setting for the attacker the goal of obtaining the exact same fingerprints in the perturbed graph is not only too strong, but more importantly, not nec- essary. Instead, we argue that it is sufficient for the attacker to obtain a set of fingerprints that is close enough to the original set of fingerprints, for some notion of closeness. Given that a fingerprint is a set of vertices, we propose to use the cardinality of the symmetric difference of two sets to measure the distance between fingerprints. The symmetric differ- ence between two sets X and Y , denoted by X(cid:79)Y , is the set of elements in X ∪ Y that are not in X ∩ Y . We use d(X, Y ) to denote X(cid:79)Y . Our goal at this stage of the attack is to create a set of fingerprints satisfying the following property. Definition 1 (Robust set of fingerprints). Given a set of victims {y1, . . . , ym} and a set of sybil nodes S in a graph G+, the set of fingerprints {F1, . . . , Fm} with Fi = NG+(yi) ∩ S is said to be robust if it maximises {d(Fi, Fj)}. min 1≤i<j≤m (1) 6 The property above ensures that the lower bound on the distance between any pair of fingerprints is maximal. In what follows, we will refer to the lower bound defined by Equation (1) as minimum separation of a set of fingerprints. For example, in Figure 1(b), the fingerprint of the vertex E with respect to the set of attacker vertices {1, 2, 3} is {2, 3}, and the fingerprint of the vertex F is {1}. This gives a minimum separation between the two victim's fingerprints equal to {2, 3}(cid:79){1} = {1, 2, 3} = 3, which is maximum. Therefore, given attacker vertices {1, 2, 3}, the set of fingerprints {{2, 3},{1}} is robust for the set of victim nodes {E, F}. Next we prove that, if the distance between each original fingerprint F and the corre- sponding anonymised fingerprint ϕF is less than half the minimum separation, then the distance between F and any other anonymised fingerprint, say ϕF (cid:48), is strictly larger than half the minimum separation. Theorem 1. Let S be the set of sybil nodes, let {y1, . . . , ym} be the set of victims and let {F1, . . . , Fm} be their fingerprints with minimum separation δ. Let F (cid:48) i be the fingerprint of ϕyi in the anonymised graph t(ϕG+), for i ∈ {1, . . . , m}. Then, ∀i∈{1,...,m}d(ϕFi, F (cid:48) i ) < δ/2 =⇒ ∀i,j∈{1,...,m}i (cid:54)= j =⇒ d(ϕFi, F (cid:48) j) > δ/2, j) ≤ δ/2 for some i, j ∈ Proof. In order to reach a contradiction, we assume that d(ϕFi, F (cid:48) {1, . . . , m} with i (cid:54)= j. Because d(ϕFj, F (cid:48) j) < δ/2, we have d(ϕFi, F (cid:48) j) < δ. By the triangle inequality we obtain that d(ϕFi, ϕFj) < d(ϕFi, F (cid:48) j) < δ. Hence d(ϕFi, ϕFj) is lower than the minimum separation of {F1, . . . , Fm}, which yields a contradiction given that d(ϕFi, ϕFj) = d(Fi, Fj) ≥ δ. j) + d(ϕFj, F (cid:48) j) + d(ϕFj, F (cid:48) 1, . . . , F (cid:48) i of yi in the perturbed graph, then for every F ∈ {F (cid:48) We exploit Theorem 1 later in the fingerprint matching step through the following corollary. If δ/2 is the maximum distance shift from an original fingerprint Fi of yi to the m} it holds that fingerprint F (cid:48) d(F, ϕFi) < δ/2 ⇐⇒ F = ϕFi. In other words, given a set of victims for which a set of fingerprints needs to be defined, the larger the minimum separation of these fingerprints, the larger the number of perturbations that can be tolerated in t(ϕG+), while still being able to match the perturbed fingerprints to their correct counterparts in G+. As illustrated earlier in our running example, the fingerprints of E and F are {2, 3} and {1}, respectively, which gives a minimum separation of δ = 3. Theorem 1 states that, if after anonymisation of the graph, the fingerprints of E and F become, say {2} and {1, 2}, respectively, then it must hold that {2, 3}(cid:79){1, 2} > 3/2 and {1}(cid:79){2} > 3/2, while {2, 3}(cid:79){2} < 3/2 and {1}(cid:79){1, 2} < 3/2. This makes it easy to match the original fingerprint, say {2, 3}, with the correct perturbed fingerprint {2} by calculating their distance and verifying that it remains below the threshold δ/2. In Subsection 4.1, we will describe an efficient algorithm for addressing this optimisation problem. 7 t(ϕG+) X ⊆ Vt(ϕG+),X = S,(cid:104)X(cid:105)w 3.2 Robust attacker subgraph retrieval Let C = {(cid:104)X(cid:105)w G+} be the set of all subgraphs isomorphic to the attacker subgraph (cid:104)S(cid:105)w G+ and weakly induced in t(ϕG+) by a vertex subset of cardinality S. The original active attack formulation [1] assumes that C = 1 and that the subgraph in C is the image of the attacker subgraph after pseudonymisation. This assumption, for example, holds on the pseudonymised graph in Figure 1(c). But it hardly holds on perturbed graphs as demonstrated in [11, 17, 18, 19] . In fact, C becomes empty by simply adding an edge between any pair of attacker nodes, which makes the attack fail quickly when increasing the amount of perturbation. ∼= (cid:104)S(cid:105)w t(ϕG+) To account for the occurrence of perturbations in releasing t(ϕG+), we introduce the notion of robust attacker subgraph retrieval. Rather than limiting the retrieval process to finding an exact match of the original attacker subgraph, we consider that it is enough to find a sufficiently similar subgraph, thus adding some level of noise-tolerance. By "sufficiently similar", we mean a graph that minimises some graph dissimilarity measure ∆ : G × G → R+ with respect to (cid:104)S(cid:105)w G+. The problem is formulated as follows. Definition 2 (Robust attacker subgraph retrieval problem). Given a graph dissimilarity measure ∆ : G×G → R+, and a set S of sybil nodes in the graph G+, find a set S(cid:48) ⊆ Vt(ϕG+) that minimises ∆((cid:104)S(cid:48)(cid:105)w t(ϕG+),(cid:104)S(cid:105)w G+). (2) A number of graph (dis)similarity measures have been proposed in the literature [28, 1, 2, 9, 16]. Commonly, the choice of a particular measure is ad hoc, and depends on the characteristics of the graphs being compared. In Subsection 4.2, we will describe a measure that is efficiently computable and exploits the known structure of (cid:104)S(cid:105)w G+, by separately ac- counting for inter-sybil and sybil-to-non-sybil edges. Along with this dissimilarity measure, we provide an algorithm for constructively finding a solution to the problem enunciated in Definition 2. 3.3 Robust fingerprint matching As established by the attacker-defender game discussed in Section 2, fingerprint matching is the last stage of the active attack. Because it clearly relies on the success of the previous steps, we make the following two assumptions upfront. 1. We assume that the robust sybil subgraph retrieval procedure succeeds, i.e. that ϕS = S(cid:48) where S(cid:48) is the set of sybil nodes obtained in the previous step. 2. Given the original set of victims Y , we assume that the set of vertices in the neigh- bourhood of S(cid:48) contains those in ϕY , i.e. ϕY ⊆ Nt(ϕG+)(S(cid:48)) \ S(cid:48), otherwise S(cid:48) is insufficient information to achieve the goal of re-identifying all victim vertices. Given a potentially correct set of sybil nodes S(cid:48) and a set of potential victims Y (cid:48) = n} = Nt(ϕG+)(S(cid:48)) \ S(cid:48), the re-identification process consists in determining the 1, . . . , y(cid:48) {y(cid:48) 8 isomorphism ϕ restricted to the vertices in Y (cid:48). Next we define re-identification as an optimisation problem, and after that we provide sufficient conditions under which a solution leads to correct identification. Definition 3 (Robust re-identification problem). Let S and S(cid:48) be the set of sybil nodes in the original and anonymised graph, respectively. Let {y1, . . . , ym} be the victims in G+ with fingerprints F1 = NG+(y1)∩S, . . . , Fm = NG+(ym)∩S. The robust re-identification problem consists in finding an isomorphism φ : S → S(cid:48) and subset {z1, . . . , zm} ⊆ Nt(ϕG+)(S(cid:48)) \ S(cid:48) that minimises (cid:107)(d(φF1, Nt(ϕG+)(z1) ∩ S(cid:48)), . . . , d(φFm, Nt(ϕG+)(zm) ∩ S(cid:48)))(cid:107)∞. (3) where (cid:107).(cid:107)∞ stands for the infinity norm. Optimising the infinity norm gives the lowest upper bound on the distance between an original fingerprint and the fingerprint of a vertex in the perturbed graph. This is useful towards the goal of correctly re-identifying all victims. However, should the adversary aims at re-identifying at least one victim with high probability, then other plausible objective functions can be used, such as the Euclidean norm. As stated earlier, our intention is to exploit the result of Theorem 1, provided that the distance between original and perturbed fingerprints is lower than δ/2, where δ is the minimum separation of the original set of fingerprints. This is one out of three conditions that we prove sufficient to infer a correct mapping ϕ from a solution to the robust re- identification problem, as stated in the following result. Theorem 2. Let φ : S → S(cid:48) and {z1, . . . , zm} be a solution to the robust re-identification problem defined by the set of sybil nodes S in the original graph G+, the set of sybil nodes S(cid:48) in the anonymised graph t(ϕG+), and the set of victims {y1, . . . , ym} in G+. Let {F1, . . . , Fm} be the set of fingerprints of {y1, . . . , ym} and δ its minimum separation. If the following three conditions hold: 1. φ is a subset of ϕ, i.e. ∀x∈Sφ(x) = ϕ(x) 2. {ϕ(y1), . . . , ϕ(ym)} = Nt(ϕG+)(S(cid:48)) \ S(cid:48) 3. For every yi ∈ {y1, . . . , ym}, d(ϕFi, F (cid:48) i ) < δ/2 where F (cid:48) i = Nt(ϕG+)(ϕ(yi)) ∩ S(cid:48), then ϕ(yi) = zi for every i ∈ {1, . . . , m}. Proof. From the third condition we obtain that the correct mapping ϕ satisfies, max{d(ϕF1, F (cid:48) 1), . . . , d(ϕFm, F (cid:48) m)} < δ/2, Now, the second condition gives that {ϕ(y1), . . . , ϕ(ym)} = {z1, . . . , zm}. This means i = Nt(ϕG+)(zj) ∩ S(cid:48) for some j ∈ {1, . . . , m}. Let f be an i = Nt(ϕG+)(zf (i)) ∩ S(cid:48) for every i ∈ {1, . . . , m}. that, for every i ∈ {1, . . . , m}, F (cid:48) automorphism in {1, . . . , m} such that F (cid:48) 9 We use f−1 to denote the inverse of f . Then, considering that φFi = ϕFi for every i ∈ {1, . . . , m} (first condition), we obtain the following equalities. max{d(φF1, Nt(ϕG+)(z1) ∩ S(cid:48)), . . . , d(φFm, Nt(ϕG+)(zm) ∩ S(cid:48))} = max{d(ϕF1, Nt(ϕG+)(z1) ∩ S(cid:48)), . . . , d(ϕFm, Nt(ϕG+)(zm) ∩ S(cid:48))} = max{d(ϕF1, F (cid:48) f−1(1)), . . . , d(ϕFm, F (cid:48) f−1(m))} Considering Theorem 1, we obtain that for every i, j ∈ {1, . . . , m} with i (cid:54)= j it holds j) > δ/2. Therefore, if f is not the trivial automorphism, i.e. f (i) = i ∀i ∈ that d(ϕFi, F (cid:48) {1, . . . , m}, then max{d(ϕF1, F (cid:48) f−1(1)), . . . , d(ϕFm, F (cid:48) f−1(m))} > δ/2. This implies that, max{d(φF1, Nt(ϕG+)(z1) ∩ S(cid:48)), . . . , d(φFm, Nt(ϕG+)(zm) ∩ S(cid:48))} > δ/2, However, this contradicts the optimality of the solution φ and {z1, . . . , zm}. Therefore, f must be the trivial automorphism, which concludes the proof. In Theorem 2, the first condition states that the adversary succeeded on correctly identifying each of her own sybil nodes in the perturbed graph. That is to say, the adver- sary retrieved the mapping ϕ restricted to the set of victims. This is clearly an important milestone in the attack as victim's fingerprints are based on such mapping. The second con- dition says that the neighbours of the sybil vertices remained the same after perturbation. As a result, the adversary knows that {z1, . . . , zm} is the victim set in the perturbed graph, but she does not know yet the isomorphism ϕ restricted to the set of victims {y1, . . . , ym}. Lastly, the third condition states that δ/2 is an upper bound on the distance between a victim's fingerprints in the pseudonymised graph ϕG+ and the perturbed graph t(ϕG+), where δ is the the minimum separation between the victim's fingerprints. In other words, the transformation method did not perturbed a victim's fingerprint "too much". If those three conditions hold, Theorem 2 shows that the isomorphism ϕ restricted to the set of victims {y1, . . . , ym} is the trivial isomorphism onto {z1, . . . , zm}. Summing up: robust active attacks, namely: in this section we have enunciated the three problem formulations for • Creating a robust set of fingerprints. • Robustly retrieving the attacker subgraph in the perturbed graph. • Robustly matching the original fingerprints to perturbed fingerprints. Additionally, we have defined a set of conditions under which finding a solution for these problems guarantees a robust active attack to be successful. Each of the three enunciated problem has been stated as an optimisation task. Since obtaining exact solutions to these problems is computationally expensive, in the next section we introduce heuristics for finding approximate solutions. 10 4 Heuristics for an approximate instance of the ro- bust active attack strategy In this section we present the techniques for creating an instance of the robust active attack strategy described in the previous section. Since finding exact solutions to the optimisation problems in Equations (1), (2) and (3) is computationally expensive, we provide efficient approximate heuristics. 4.1 Attacker subgraph creation For creating the internal links of the sybil subgraph, we will use the same strategy as the so-called walk-based attack [1], which is the most widely-studied instance of the original active attack strategy. By doing so, we make our new attack as (un)likely as the original to have the set of sybil nodes removed by sybil defences. Thus, for the set of sybil nodes S, the attack will set an arbitrary (but fixed) order among the elements of S. Let x1, x2, . . . , xS represent the vertices of S in that order. The attack will firstly create the path x1x2 . . . xS, whereas the remaining inter-sybil edges are independently created with probability 0.5. For creating the set of fingerprints, we will apply a greedy algorithm for maximising the minimum separation defined in Equation (1). The idea behind the algorithm is to arrange all possible fingerprints in a grid-like auxiliary graph, in such a way that nodes repre- senting similar fingerprints are linked by an edge, and nodes representing well-separated fingerprints are not. Looking for a set of maximally separated fingerprints in this graph re- duces to a well-known problem in graph theory, namely that of finding an independent set. An independent set I of a graph G is a subset of vertices from G such that E(cid:104)I(cid:105)G = ∅, that is, all vertices in I are pairwise not linked by edges. If the graph is constructed in such a way that every pair of fingerprints whose distance is less then or equal to some value i, then an independent set represents a set of fingerprints with a guaranteed minimum separation of at least i + 1. For example, the fingerprint graph shown in Figure 2 (a) represents the set of fingerprints {{1},{2},{3},{1, 2},{1, 3},{2, 3},{1, 2, 3}}, with edges linking all pairs X, Y of fingerprints such that d(X, Y ) ≤ 1, whereas Figure 2 (b) represents an analogous graph where edges link all pairs X, Y of fingerprints such that d(X, Y ) ≤ 2. Note that the vertex set of both graphs is the power set of {1, 2, 3}, except for the empty set, which does not represent a valid fingerprint, as every victim must be linked to at least one sybil node. A set of fingerprints built from an independent set of the first graph may have minimum separation 2 (e.g. {{1},{2},{1, 2, 3}}) or 3 (e.g. {{1, 3},{2}}), whereas a set of finger- prints built from an independent set of the second graph will have minimum separation 3 (the independent sets of this graph are {{1},{2, 3}}, {{1, 2},{3}} and {{1, 3},{2}}). Our fingerprint generation method iteratively creates increasingly denser fingerprint graphs. The vertex set of every graph is the set of possible fingerprints, i.e. all subsets of S except the empty set. In the i-th graph, every pair of nodes X, Y such that d(X, Y ) ≤ i will be linked by an edge. Thus, an independent set of this graph will be composed of 11 {3} {1, 3} {1} {2, 3} {1, 3} {1, 2, 3} {2} {1} {1, 2} (a) {3} {1,2,3} {1, 2} (b) {2, 3} {2} Figure 2: The fingerprint graphs (P({1, 2, 3}) \ {∅},{(X, Y ) {∅}, X (cid:54)= Y, d(X, Y ) ≤ i}) for (a) i = 1 and (b) i = 2. X, Y ∈ P({1, 2, 3}) \ nodes representing fingerprints whose minimum separation is at least i + 1. A maximal2 independent set of the fingerprint graph is computed in every iteration, to have an approx- imation of a maximum-cardinality set of uniformly distributed fingerprints with minimum separation at least i + 1. For example, in the graph of Figure 2 (a), the method will find {{1},{2},{3},{1, 2, 3}} as a maximum-cardinality set of uniformly distributed fingerprints with minimum separation 2; whereas for the graph of Figure 2 (b), the method will find, for instance, {{1},{2, 3}} as a maximum-cardinality set of uniformly distributed fingerprints with minimum separation 3. The method iterates until finding the smallest maximal inde- pendent set that still contains at least m fingerprints, that is, at least as many fingerprints as original victims, so a different fingerprint can be assigned to every victim. If this set does not contain exactly m fingerprints, it is used as a pool, from which successive runs of the attack randomly draw m fingerprints. Algorithm 1 lists the pseudo-code of this method. F is 2S − 1. Thus, the time complexity of In Algorithm 1, the order of every graph G(i) every graph construction is O(cid:16)(cid:0)2S(cid:1)2(cid:17) = O(cid:0)22S(cid:1). Moreover, the greedy algorithm for graph, so in this case its time complexity is also O(cid:0)22S(cid:1). Finally, since the maximum Algorithm 1 is O(cid:0)S · 22S(cid:1). This worst case occurs when the number of victims is very finding a maximal independent set runs in quadratic time with respect to the order of the possible distance between a pair of fingerprints is S, the worst-case time complexity of small, as the number of times that steps 4 to 9 of the algorithm are repeated is more likely to approach S. While this time complexity may appear as excessive at first glance, we must consider that, for a social graph of order n, the algorithm will be run for sets of sybil nodes having at most cardinality S = log2 n. Thus, in terms of the order of the social 2The maximum independent set problem is NP-hard, so it is infeasible to exactly compute a maximum independent set of every graph. Alternatively, we use a well known greedy approximation, which consists in iteratively finding a minimum-degree non-isolated vertex, and removing all its neighbours, until obtaining an empty graph, whose vertex set is an independent set of the original graph. 12 (cid:17) (cid:16) F ← (P(S) \ ∅,{(X, Y ) X, Y ∈ P(S) \ ∅, X (cid:54)= Y, d(X, Y ) ≤ 1}) Algorithm 1 Given a set S of sybil nodes, compute a uniformly distributed set of finger- prints of size at least m. 1: i ← 1 2: G(1) 3: I1 ← MaxIndSet 4: repeat 5: 6: 7: F ← Ii i ← i + 1 F ← (P(S) \ ∅,{(X, Y ) X, Y ∈ P(S) \ ∅, X (cid:54)= Y, d(X, Y ) ≤ i}) G(i) Ii ← MaxIndSet G(1) F 8: 9: until Ii < m 10: return F (cid:17) (cid:16) G(i) F repeat 1: function MaxIndSet(G = (VG, EG)) 2: v ← arg minv∈VG,δG(v)(cid:54)=0 {δG(v)} 3: EG ← EG \ {(v, w) w ∈ NG(v)} 4: VG ← VG \ NG(v) 5: 6: 7: until EG = ∅ return VG graph, the worst-case running time will be O(n2 log2 n). 4.2 Attacker subgraph retrieval As discussed in Subsection 3.2, in the original formulation of active attacks, the sybil re- trieval phase is based on the assumption that the attacker subgraph can be uniquely and exactly matched to a subgraph of the released graph. This assumption is relaxed by the formulation of robust attacker subgraph retrieval given in Definition 2, which accounts for the possibility that the attacker subgraph has been perturbed. The problem formulation given in Definition 2 requires a dissimilarity measure ∆ to compare candidate subgraphs to the original attacker subgraph. We will introduce such a measure in this section. More- over, the problem formulation requires searching the entire power set of Vt(ϕG+), which is infeasible in practice. In order to reduce the size of the search space, we will establish a perturbation threshold ϑ, and the search procedure will discard any candidate subgraph X such that ∆((cid:104)X(cid:105)w We now define the dissimilarity measure ∆ that will be used. To that end, some additional notation will be necessary. For a graph H, a vertex set V ⊆ VH, and a complete order ≺⊆ V × V , we will define the vector v≺ = (vi1, vi2, . . . , viV ), as the one satisfying vi1 ≺ vi2 ≺ . . . ≺ viV . When the order ≺ is fixed or clear from the context, we will simply refer to v≺ as v. Moreover, for the sake of simplicity in presentation, we will in some cases t(ϕG+),(cid:104)S(cid:105)w G+) > ϑ. 13 H for (cid:104)V (cid:105)w abuse notation and use v for V , (cid:104)v(cid:105)w H, and so on. The search procedure assumes the existence of a fixed order ≺S on the original set of sybil nodes S, which is established at the attacker subgraph creation stage, as discussed in Subsection 4.1. In what follows, we will use the notation s = (x1, x2, . . . , xS) for the vector s≺S . G+ and a subgraph of t(ϕG+) weakly induced by a candidate vector v = (v1, v2, . . . , vS), the dissimilarity measure ∆ will compare (cid:104)v(cid:105)w G+ according to the following criteria: Given the original attacker subgraph (cid:104)S(cid:105)w t(ϕG+) to (cid:104)S(cid:105)w • The set of inter-sybil edges of (cid:104)S(cid:105)w t(ϕG+). This is equivalent to comparing E((cid:104)S(cid:105)G+) and E((cid:104)v(cid:105)t(ϕG+)). To that end, we will apply to (cid:104)S(cid:105)G+ the isomorphism ϕ(cid:48) : (cid:104)S(cid:105)G+ → (cid:104)v(cid:105)t(ϕG+), which makes ϕ(cid:48)(xi) = vi for every i ∈ {1, . . . ,S}. The contribution of inter-sybil edges to ∆ will thus be defined as G+ will be compared to that of (cid:104)v(cid:105)w (cid:17) =(cid:12)(cid:12)E(ϕ(cid:48)(cid:104)S(cid:105)G+)(cid:79)E((cid:104)v(cid:105)t(ϕG+))(cid:12)(cid:12) , (cid:16)(cid:104)S(cid:105)w G+,(cid:104)v(cid:105)w ∆syb t(ϕG+) (4) • The set of sybil-to-non-sybil edges of (cid:104)S(cid:105)w that is, the symmetric difference between the edge sets of ϕ(cid:48)(cid:104)S(cid:105)G+ and (cid:104)v(cid:105)t(ϕG+). G+ will be compared to that of (cid:104)v(cid:105)w t(ϕG+). Unlike the previous case, where the orders ≺S and ≺v allow to define a trivial isomor- phism between the induced subgraphs, in this case creating the appropriate match- ing would be equivalent to solving the re-identification problem for every candidate subgraph, which is considerably inefficient. In consequence, we introduce a relaxed criterion, which is based on the numbers of non-sybil neighbours of every sybil node, which we refer to as marginal degrees. The marginal degree of a sybil node x ∈ S is thus defined as δ(cid:48) δ(cid:48) (cid:104)v(cid:105)w to ∆ will be defined as (cid:12)(cid:12)(cid:12). By analogy, for a vertex v ∈ v, we define (cid:12)(cid:12)(cid:12)N(cid:104)S(cid:105)w (cid:12)(cid:12)(cid:12). Finally, the contribution of sybil-to-non-sybil edges (cid:12)(cid:12)(cid:12)(cid:12)δ(cid:48) (cid:17) S(cid:88) (cid:16)(cid:104)S(cid:105)w (cid:12)(cid:12)(cid:12)N(cid:104)v(cid:105)w (cid:16)(cid:104)S(cid:105)w (cid:17) • The dissimilarity measure combines the previous criteria as follows: (cid:16)(cid:104)S(cid:105)w (cid:16)(cid:104)S(cid:105)w G+,(cid:104)v(cid:105)w (vi) − δ(cid:48) (x) \ S (v) \ v ∆neigh (x) = (v) = (cid:17) (cid:17) (cid:12)(cid:12)(cid:12)(cid:12) (xi) t(ϕG+) (cid:104)S(cid:105)w (cid:104)S(cid:105)w (cid:104)v(cid:105)w t(ϕG+) G+,(cid:104)v(cid:105)w t(ϕG+) G+,(cid:104)v(cid:105)w t(ϕG+) G+,(cid:104)v(cid:105)w t(ϕG+) + ∆neigh = i=1 G+ t(ϕG+) (5) (6) t(ϕG+) G+ G+ ∆ = ∆syb G+ Figure 3 shows an example of the computation of this dissimilarity measure, with s = (x1, x2, x3, x4, x5) and v = (v1, v2, v3, v4, v5). In the figure, we can observe that (x1, x3) ∈ In E(cid:104)S(cid:105)w consequence, (x2) = ∅ = 0, ∆syb (cid:104)S(cid:105)w (vi) for i ∈ {1, 3, 4, 5}, whereas δ(cid:48) (cid:17) and (v1, v3) /∈ E(cid:104)v(cid:105)w G+,(cid:104)v(cid:105)w (cid:104)v(cid:105)w = 2. Moreover, we can also observe that δ(cid:48) , whereas (x3, x4) ∈ E(cid:104)S(cid:105)w and (v3, v4) /∈ E(cid:104)v(cid:105)w 5} = 2. Since δ(cid:48) (cid:16)(cid:104)S(cid:105)w (v2) = {y(cid:48) (xi) = δ(cid:48) 1, y(cid:48) t(ϕG+) (cid:104)S(cid:105)w (cid:104)v(cid:105)w t(ϕG+) t(ϕG+) G+ G+ . G+ t(ϕG+) t(ϕG+) 14 we have ∆neigh = 4. It is simple to see that the value of the dissimilarity function is dependent on the order imposed by the vector v. For example, consider the vector v(cid:48) = (v5, v2, v3, v4, v1). We can verify3 that now = 4, so the dissimilarity ∆syb (cid:16)(cid:104)S(cid:105)w = 4, whereas ∆neigh = 2, so ∆ t(ϕG+) t(ϕG+) G+,(cid:104)v(cid:48)(cid:105)w G+,(cid:104)v(cid:48)(cid:105)w t(ϕG+) t(ϕG+) G+,(cid:104)v(cid:105)w (cid:16)(cid:104)S(cid:105)w (cid:16)(cid:104)S(cid:105)w (cid:17) (cid:17) (cid:16)(cid:104)S(cid:105)w (cid:16)(cid:104)S(cid:105)w G+,(cid:104)v(cid:105)w (cid:17) G+,(cid:104)v(cid:48)(cid:105)w (cid:17) (cid:17) value is now ∆ t(ϕG+) y1 y2 = 8. y3 z1 z2 z3 x1 x2 x3 x4 x5 v1 v2 v3 v4 v5 y4 (cid:104)S(cid:105)w G+ z5 z4 (cid:104)v(cid:105)w t(ϕG+) Figure 3: An example of possible graphs (cid:104)S(cid:105)w coloured in gray. G+ and (cid:104)v(cid:105)w t(ϕG+). Vertices in S and v are The search procedure assumes that the transformation t did not remove the image of any sybil node from ϕG+, so it searches the set of cardinality-S permutations of elements from Vt(ϕG+), respecting the tolerance threshold. The method is a breadth-first search, which analyses at the i-th level the possible matches to the vector (x1, x2, . . . , xi) composed of the first i components of s. The tolerance threshold ϑ is used to prune the search tree. A detailed description of the procedure is shown in Algorithm 2. Ideally, the algorithm outputs a unitary set C∗ = {(vj1, vj2, . . . , vjS)}, in which case the vector v = (vj1, vj2, . . . , vjS) is used as the input to the fingerprint matching phase, described in the following subsection. If this is not the case, and the algorithm yields C∗ = {v1, v2, . . . , vt}, the attack randomly picks an element vi ∈ C∗ and proceeds to the fingerprint matching phase. Finally, if C∗ = ∅, the attack is considered to fail, as no re-identification is possible. To conclude, we point out that if Algorithm 2 is run with ϑ = 0, then C∗ contains exactly the same candidate set that would be recovered by the attacker subgraph retrieval phase of the original walk-based attack. 3We now have that (x1, x2) ∈ E(cid:104)S(cid:105)w and (v5, v2) /∈ E(cid:104)v(cid:48)(cid:105)w ; (x1, x3) ∈ E(cid:104)S(cid:105)w (cid:12)(cid:12)(cid:12)(cid:12) = 1, t(ϕG+ ) ; and (x3, x4) ∈ E(cid:104)S(cid:105)w (v2) − δ(cid:48) G+ (cid:104)v(cid:48)(cid:105)w (cid:12)(cid:12)(cid:12)(cid:12)δ(cid:48) t(ϕG+ ) t(ϕG+ ) (x1) G+ and (v5, v3) /∈ whereas (v3, v4) /∈ (cid:12)(cid:12)(cid:12)(cid:12) = 2 and (x2) G+ (cid:104)S(cid:105)w ; (x2, x5) /∈ E(cid:104)S(cid:105)w G+ and (v2, v1) ∈ E(cid:104)v(cid:48)(cid:105)w E(cid:104)v(cid:48)(cid:105)w t(ϕG+ ) E(cid:104)v(cid:48)(cid:105)w t(ϕG+) (cid:104)v(cid:48)(cid:105)w t(ϕG+ ) (cid:12)(cid:12)(cid:12)(cid:12)δ(cid:48) . Moreover, now (v1) − δ(cid:48) (x5) (cid:104)S(cid:105)w G+ G+ (cid:12)(cid:12)(cid:12)(cid:12)δ(cid:48) (cid:12)(cid:12)(cid:12)(cid:12) = 1. (cid:104)v(cid:48)(cid:105)w (v5) − δ(cid:48) (cid:104)S(cid:105)w G+ t(ϕG+ ) 15 5: 6: 7: 8: 9: 13: 14: else 15: 16: 10: if P artialCandidates1 = ∅ then 12: else if S = 1 then return ∅ 11: return P artialCandidates1 Algorithm 2 Given the graphs G+ and t(ϕG+), the set of original sybil nodes S ⊆ VG+, and the maximum distance threshold ϑ, obtain the set C∗ of equally-likely best candidate sybil sets. 1: (cid:46) Find suitable candidates to match x1 2: P artialCandidates1 ← ∅ 3: d ← ϑ 4: for v ∈ Vt(ϕG+) do if ∆ < d then (cid:17) G+,(cid:104)(v)(cid:105)w (cid:16)(cid:104)(x1)(cid:105)w (cid:16)(cid:104)(x1)(cid:105)w (cid:16)(cid:104)(x1)(cid:105)w t(ϕG+) P artialCandidates1 ← {(v)} d ← ∆ t(ϕG+) G+,(cid:104)(v)(cid:105)w G+,(cid:104)(v)(cid:105)w (cid:17) (cid:17) else if ∆ P artialCandidates1 ← P artialCandidates1 ∪ {(v)} t(ϕG+) = d then (cid:46) Find rest of matches for candidates return Breadth-First-Search(2, P artialCandidates1) (cid:46) Algorithm 3 4.3 Fingerprint matching Now, we describe the noise-tolerant fingerprint matching process. Let Y = {y1, . . . , ym} ⊆ VG+ represent the set of victims. Let S be the original set of sybil nodes and S(cid:48) ⊆ Vt(ϕG+) a candidate obtained by the sybil retrieval procedure described above. As in the previous subsection, let s = (x1, x2, . . . , xS) be the vector containing the elements of S in the order imposed at the sybil subgraph creation stage. Moreover, let (cid:104)v(cid:105)w t(ϕG+), with v = (v1, v2, . . . , vS) ∈ C∗, be a candidate sybil subgraph, retrieved using Algorithm 2. Finally, for every i ∈ {1, . . . , m}, let Fi ⊆ S be the original fingerprint of the victim yi and φFi ⊆ v its image by the isomorphism mapping s to v. We now describe the process for finding Y (cid:48) = {y(cid:48) i = ϕ(yi), using φF1, φF2, . . . , φFm, s and v. If the perturbation t(G+) had caused no damage to the fingerprints, checking for the exact matches is sufficient. Since, as previously discussed, this is usually not the case, we will introduce a noise-tolerant fingerprint matching strategy that maps every original fingerprint to its most similar candidate fingerprint, within some tolerance threshold β. Algorithm 4 describes the process for finding the set of optimal re-identifications. For a candidate victim z ∈ Nt(ϕG+)(v) \ v, the algorithm denotes as Fz,v = Nt(ϕG+)(z) ∩ v its fingerprint with respect to v. The algorithm is a depth-first search procedure. First, the algorithm finds, for every φFi, i ∈ {1, . . . , m}, the set of most similar candidate fingerprints, m} ⊆ Vt(ϕG+), where y(cid:48) 1, . . . , y(cid:48) 16 Algorithm 3 Function Breadth-First-Search, used in Algorithm 2. 1: function Breadth-First-Search(i, P artialCandidatesi−1) 2: 3: 4: 5: 6: 7: 8: 9: 10: (cid:46) Find suitable candidates to match (x1, x2, . . . , xi) s(cid:48) ← (x1, x2, . . . , xi) P artialCandidatesi ← ∅ d ← ϑ for (vj1, vj2, . . . , vji−1) ∈ Ci−1 do (cid:17) v(cid:48) ← (vj1, vj2, . . . , vji−1, w) if ∆ ExtendedCandidates ← ∅ d(cid:48) ← ϑ for w ∈ Vt(ϕG+) \ (vj1, vj2, . . . , vji−1) do (cid:16)(cid:104)s(cid:48)(cid:105)w (cid:16)(cid:104)s(cid:48)(cid:105)w (cid:16)(cid:104)s(cid:48)(cid:105)w G+,(cid:104)v(cid:48)(cid:105)w < d(cid:48) then ExtendedCandidates ← {v(cid:48)} d(cid:48) ← ∆ t(ϕG+) (cid:17) (cid:17) G+,(cid:104)v(cid:48)(cid:105)w G+,(cid:104)v(cid:48)(cid:105)w t(ϕG+) ExtendedCandidates ← ExtendedCandidates ∪ {v(cid:48)} t(ϕG+) = d(cid:48) then else if ∆ if d(cid:48) < d then P artialCandidatesi ← ExtendedCandidates d ← d(cid:48) P artialCandidatesi ← P artialCandidatesi ∪ ExtendedCandidates else if d(cid:48) = d then 11: 12: 13: 14: 15: 16: 17: 18: 19: 20: 21: 22: 23: 24: 25: 26: 27: if P artialCandidatesi = ∅ then else if i = S then return ∅ return P artialCandidatesi else (cid:46) Find rest of matches for candidates return Breadth-First-Search(i + 1, P artialCandidatesi) 17 G+ and (cid:104)v(cid:105)w To illustrate how the method works, recall the graphs (cid:104)S(cid:105)w and keeps the set of matches that reach the minimum distance. From these best matches, one or several partial re-identifications are obtained. The reason why more than one partial re-identification is obtained is that more than one candidate fingerprint may be equally similar to some φFi. For every partial re-identification, the method recursively finds the set of best completions and combines them to construct the final set of equally likely re- identifications. The search space is reduced by discarding insufficiently similar matches. For any candidate victim z and any original victim yi such that d( Fz,v, φFi) < β, the algorithm discards all matchings where ϕ(yi) = z. t(ϕG+) depicted in Figure 3. The original set of victims is Y = {y1, y2, y3, y4} and their fingerprints are F1 = {x1}, F2 = {x1, x3}, F3 = {x3, x5}, and F4 = {x3}, respectively. In consequence, we have φF1 = {v1}, φF2 = {v1, v3}, φF3 = {v3, v5}, and φF4 = {v3}. The set of candidate victims is Nt(ϕG+)(v)\ v = {z1, z2, z3, z4, z5}. The method will first find all exact matchings, that is ϕ(y2) = z2, ϕ(y3) = z3, and ϕ(y4) = z4, because the distances between the corresponding fingerprints is zero in all three cases. Since none of these matchings is ambiguous, the method next determines the match ϕ(y1) = z1, because d( Fz1, φF1) = d({v1, v2},{v1}) = 1 < 2 = d({v2},{v1}) = d( Fz5, φF1). At this point, the method stops and yields the unique re-identification {(y1, z1), (y2, z2), (y3, z3), (y4, z4)}. Now, suppose that the vertex z5 is linked in t(ϕG+) to v3, instead of v2, as depicted in Figure 4. In this case, the method will unambiguously determine the matchings ϕ(y2) = z2 and ϕ(y3) = z3, and then will try the two choices ϕ(y4) = z4 and ϕ(y4) = z5. In the first case, the method will make ϕ(y1) = z1 and discard z5. Analogously, in the second case the method will also make ϕ(y1) = z1, and will discard z4. Thus, the final result will consist in two equally likely re-identifications, namely {(y1, z1), (y2, z2), (y3, z3), (y4, z4)} and {(y1, z1), (y2, z2), (y3, z3), (y4, z5)}. y1 y2 y3 z1 z2 z3 x1 x2 x3 x4 x5 v1 v2 v4 v5 v3 z4 y4 (cid:104)S(cid:105)w G+ z5 (cid:104)v(cid:105)w t(ϕG+) Figure 4: Alternative example of possible graphs (cid:104)S(cid:105)w G+ and (cid:104)v(cid:105)w t(ϕG+). Ideally, Algorithms 2 and 4 both yield unique solutions, in which case the sole element in the output of Algorithm 4 is given as the final re-identification. If this is not the case, the attack picks a random candidate sybil subgraph from C∗, uses it as the input of Algorithm 4, and picks a random re-identification from its output. If either algorithm yields an empty solution, the attack fails. Finally, it is important to note that, if Algorithm 2 is run with ϑ = 0 and Algorithm 4 is run with β = 0, then the final result is exactly the same set of equally likely matchings that would be obtained by the original walk-based attack. 18 Algorithm 4 Given the graphs G+ and t(ϕG+), the original set of victims Y = {y1, y2, . . . , ym}, the original fingerprints F1, F2, . . . , Fm, a candidate set of sybils v, and the maximum distance threshold β, obtain the set ReIdents of best matchings. 1: (ReIdents, d) ← GreedyMatching(Y , Nt(ϕG+)(v) \ v) 2: return ReIdents (cid:46) Find best matches of some unmapped victim(s) to one or more candidate victims M apP artialBest ← ∅ d ← β for yi ∈ Y do for z ∈ M do 1: function GreedyMatching(Y , M ) 2: 3: 4: 5: 6: 7: 8: 9: 10: 11: 12: 13: 14: if d( Fz,v, φFi) < d then else M apP artialBest ← {(yi,{z})} d ← d( Fz,v, φFi) if (yi, P ) ∈ M apP artialBest then else if d( Fz,v, φFi) = d then if M apP artialBest = ∅ then return (∅, +∞) else M apP artialBest ← (M apP artialBest \ (yi, P )) ∪ {(yi, P ∪ {z})} M apP artialBest ← M apP artialBest ∪ {(yi, P ∪ {z})} 15: 16: 17: 18: 19: 20: 21: 22: 23: 24: 25: 26: 27: 28: 29: 30: 31: 32: 33: 34: 35: 36: (cid:46) Build partial re-identifications from best matches Pick any (y, P ) ∈ M apP artialBest P artialReIdents ← {(y, z) z ∈ P} for (y(cid:48), P (cid:48)) ∈ M apP artialBest \ (y, P ) do P artialReIdents ← {R ∪ {y(cid:48), z(cid:48)} R ∈ P artialReIdents ∧ z(cid:48) ∈ P (cid:48)} if Y = 1 then return (P artialReIdents, d) else (cid:46) Recursively find best completions for partial re-identifications BestComplReIdent ← ∅ dbest ← β for R ∈ P artialReIdents do (CompletedReIdents, d) ← GreedyMatching(Y \ {y (y, z) ∈ R}, M \ {z (y, z) ∈ R}) if d < dbest then BestComplReIdent ← CompletedReIdents dbest ← d BestComplReIdent ← BestComplReIdent ∪ CompletedReIdents return ({P ∪ R P ∈ P artialReIdents ∧ R ∈ BestComplReIdent}, dbest) else if d = dbest then 19 5 Experiments The purpose of our experiments is to show the considerable gain in resiliency of the pro- posed robust active attack, in comparison to the original attack. We used for our exper- iments a collection of randomly generated synthetic graphs. This collection is composed of 10, 000 graphs for each density value in the set {0.05, 0.1, . . . , 1}. Each graph has 200 vertices4, and its edge set is randomly generated in such a manner that the desired density value is met. As discussed in [1], for a graph having n vertices, it suffices to insert log n sybil nodes for being able to compromise any possible victim, while it has been shown in [35, 34] that even the so-called near-optimal sybil defences do not aim to remove every sybil node, but to limit their number to around log n. In light of these two considerations, when evaluating each attack strategy on the collection of randomly generated graphs, we use 8 sybil nodes. Given the set S of sybil nodes, the original attack randomly creates any set of fingerprints from P(S) \ ∅. In the case of the robust attack, the pool of uniformly distributed fingerprints was generated in advance and, if it is larger than the number of victims, different sets of fingerprints of size Y are randomly drawn from the pool at every particular run. Moreover, in Algorithms 2 and 4, we made ϑ = β = 8. For every graph in the collection, after simulating the attacker subgraph creation stage of each attack, and the pseudonymisation performed by the defender, we generate six variants of perturbed graphs using the following methods: (a) The method proposed in [19] for enforcing (k, (cid:96))-anonymity for some k > 1 or some (cid:96) > 1. (b) The method proposed in [18] for enforcing (2, ΓG,1)-anonymity. (c) The method proposed in [18] for enforcing (k, ΓG,1)-adjacency anonymity for a given value of k. Here, we will run the method with k = S, since it was empirically shown in [18] that the original walk-based attack is very likely to be thwarted in this case. (d) Randomly flipping 1% of the edges in G+. Each flip consists in randomly selecting a pair of vertices u, v ∈ VG+, removing the edge (u, v) if it belongs to EG+, or adding it in the opposite case. Since G+ has order n = 208, this perturbation performs 0.01 · n(n−1) = 215 flips. (cid:106) (cid:107) 2 (e) Randomly flipping 5% of the edges in G+ (that is, 1076 flips), in a manner analogous to the one used above. (f) Randomly flipping 10% of the edges in G+ (that is, 2153 flips), in a manner analogous to the one used above. 4We chose to use graphs of order 200 to make the results comparable to those reported in [18] for the three anonymisation methods used here. 20 Finally, we compute the probability of success of the re-identification stage for each perturbed variant. The success probability is computed as if X (cid:54)= ∅ otherwise X∈X pX X Pr = 0 (cid:40) (cid:80) (7) where X is the set of equally-likely possible sybil subgraphs retrieved in t(ϕG+) by the third phase of the attack5, and (cid:26) 1YX 0 pX = if Y ∈ YX otherwise with YX containing all equally-likely matchings6 according to X. These experiments7 were performed on the HPC platform of the University of Luxembourg [31]. Figure 5 shows the success probabilities of the two attacks on the perturbed graphs obtained by applying the strategies (a) to (f). From the analysis of the figure, it is clear that the robust attack has a consistently larger probability of success than the original walk-based attack. A relevant fact evidenced by the figure (items (a), (b) and (c)) is that the robust attack is completely effective against the anonymisation methods described in [19, 18]. As pointed out by the authors of these papers, the fact that the original walk- based attack leveraging more than one sybil node was thwarted to a considerable extent by the anonymisation methods was a side effect of the disruptions caused in the graph, rather than the enforced privacy measure itself. By successfully addressing this shortcoming, the robust active attack lends itself as a more appropriate benchmark on which to evaluate future anonymisation methods. For example, by comparing the charts in Figure 5 (a) and (b), we can see that the success probability of the original attack, for some low density values, is slightly higher for the second anonymisation method than for the first. Neither of these algorithms gives a theoretical privacy guarantee against an attacker leveraging seven sybil nodes. However, a difference in success probability is observed for the original attack, which is due to the fact that the second method introduces a smaller number of changes in the graph than the first one [18]. As can be observed in the figure, the robust attack is not affected by this difference between the methods, and allows the analyst to reach the correct conclusion that both methods fail to thwart the attack. As a final observation, by analysing items (d) and (e) in Figure 5, we can see that even 1% of random noise completely thwarts the original attack, whereas the robust attack still performs at around 0.6 success probability. The robust attack also performs acceptably well with a 5% random perturbation. (cid:110)(cid:104)v(cid:105)w t(ϕG+) v ∈ C∗(cid:111) 5Note that, for the original walk-based attack, X is the set of subgraphs of t(ϕG+) isomorphic to (cid:104)S(cid:105)w , being C∗ the output of Algorithm 2. whereas for the robust attack we have X = Fi}, whereas for the robust attack YX is the output of Algorithm 4. 6Note that, for the original walk-based attack, YX = {{y1, y2 . . . , ym} ⊆ Vt(ϕG+) ∀i∈{1,...,m}Fyi,X = G+, 7The implementations of the graph generators, anonymisation methods and attack simulations are available at https://github.com/rolandotr/graph. 21 (a) (k, (cid:96))-anonymity, k > 1 or (cid:96) > 1 [19] (b) (2, Γ1)-anonymity [18] (c) (S, Γ1)-adjacency anonymity [18] (d) 1% random perturbation (e) 5% random perturbation (f) 10% random perturbation Figure 5: Success probabilities of every attack variant on the collection of randomly gen- erated graphs, after publishing the graphs perturbed by the methods listed above. 22 0 0.2 0.4 0.6 0.8 1 0.1 0.2 0.3 0.4 0.5 0.6 0.7 0.8 0.9 1Success probabilityDensityOriginal attackRobust attack 0 0.2 0.4 0.6 0.8 1 0.1 0.2 0.3 0.4 0.5 0.6 0.7 0.8 0.9 1DensityOriginal attackRobust attack 0 0.2 0.4 0.6 0.8 1 0.1 0.2 0.3 0.4 0.5 0.6 0.7 0.8 0.9 1Success probabilityDensityOriginal attackRobust attack 0 0.2 0.4 0.6 0.8 1 0.1 0.2 0.3 0.4 0.5 0.6 0.7 0.8 0.9 1DensityOriginal attackRobust attack 0 0.2 0.4 0.6 0.8 1 0.1 0.2 0.3 0.4 0.5 0.6 0.7 0.8 0.9 1Success probabilityDensityOriginal attackRobust attack 0 0.2 0.4 0.6 0.8 1 0.1 0.2 0.3 0.4 0.5 0.6 0.7 0.8 0.9 1DensityOriginal attackRobust attack 6 Related work Privacy attacks on social networks exploit structural knowledge about the victims for re- identifying them in a released version of the social graph. These attacks can be divided in two categories, according to the manner in which the adversary obtains the knowledge used to re-identify the victims. On the one hand, passive attacks rely on existing knowledge, which can be collected from publicly available sources, such as the public view of another social network where the victims are known to have accounts. The use of this type of information was demonstrated in [21], where information from Flickr was used to re-identify users in a pseudonymised Twitter graph. On the other hand, active attacks rely on the ability to alter the structure of the social graph, in such a way that the unique structural properties allowing to re-identify the victims after publication are guaranteed to hold, and to be known by the adversary. As we discussed previously, the active attack methodology was introduced by Backstrom et al. in [1]. They proposed to use sybil nodes to create re-identifiable patterns for the victims, in the form of fingerprints defined by sybil-to-victim edges. Under this strategy, they proposed two attacks, the walk-based attack and the cut-based attack. The difference between both attacks lies in the structure given to the sybil subgraph for facilitating its retrieval after publication. In the walk-based attack, a long path linking all the sybil nodes in a predefined order is created, with remaining inter-sybil edges randomly generated. In the cut-based attack, a subset of the sybil nodes are guaranteed to be the only cut vertices linking the sybil subgraph and the rest of the graph. Interestingly, Backstrom et al. also study a passive version of these attacks, where fingerprints are used as identifying information, but no sybil nodes are inserted. Instead, they model the situation where legitimate users turn rogue and collude to share their neighbourhood information in order to retrieve their own weakly induced subgraph and re-identify some of their remaining neighbours. However, the final conclusion of this study is that the active attack is more capable because sybil nodes can better guarantee to create a uniquely retrievable subgraph and unique fingerprints. Additionally, a hybrid strategy was proposed by Peng et al. [22, 23]. This hybrid attack is composed of two stages. First, a small-scale active attack is used to re-identify an initial set of victims, and then a passive attack is used to iteratively enlarge the set of re-identified victims with neighbours of previously re-identified victims. Because of the order in which the active and the passive phases are executed, the success of the initial active attack is critical to the entire attack. A large number of anonymisation methods have been proposed for privacy-preserving publication of social graphs, which can be divided into three categories: those that produce a perturbed version of the original graph [13, 37, 38, 5, 14, 3, 6, 32, 15, 26, 24, 4], those that generate a new synthetic graph sharing some statistical properties with the original graph [10, 20, 12], and those that output some aggregate statistic of the graph without releasing the graph itself, e.g. differentially private degree correlation statistics [25]. Active attacks, both the original formulation and the robust version presented in this paper, are relevant to the first type of releases. In this context, a number of methods have been proposed aiming to transform the graph into a new one satisfying some anonymity property based 23 on the notion of k-anonymity [27, 29]. Examples of this type of anonymity properties for passive attacks are k-degree anonymity [13], k-neighbourhood anonymity [37] and k- automorphism [38]. For the case of active attacks, the notions of (k, (cid:96))-anonymity was introduced by Trujillo and Yero in [30]. A (k, (cid:96))-anonymous graph guarantees that an active attacker with the ability to insert up to (cid:96) sybil nodes in the network will still be unable to distinguish any user from at least other k − 1 users, in terms of their distances to the sybil nodes. Several relaxations of the notion of (k, (cid:96))-anonymity were introduced in in [18]. The notion of (k, (cid:96))-adjacency anonymity accounts for the unlikelihood of the adversary to know all distances in the original graph, whereas (k, ΓG,(cid:96))-anonymity models the protection of the victims only from vertex subsets with a sufficiently high re-identification probability and (k, ΓG,(cid:96))-adjacency anonymity combines both criteria. Anonymisation methods based on the notions of (k, (cid:96))-anonymity, (k, ΓG,(cid:96))-anonymity and (k, ΓG,(cid:96))-adjacency anonymity were introduced in [19, 17, 18]. As we discussed above, despite the fact that these methods only give a theoretical privacy guarantee against ad- versaries with the capability of introducing a small number of sybil nodes, empirical results show that they are in fact capable of thwarting attacks leveraging larger numbers of sybil nodes. These results are in line with the observation that random perturbations also thwart active attacks in their original formulation [21, 11]. This is a result of the fact that, originally, active attacks attempt to exactly retrieve the sybil subgraph and match the fingerprints. In the context of obfuscation methods, which aim to publish a new version of the social graph with randomly added perturbations, Xue et al. [33] assess the possibility of the attacker leveraging the knowledge about the noise generation to launch what they call a probabilistic attack. In their work, Xue et al. provided accurate estimators for several graph parameters in the noisy graphs, to support the claim that useful computations can be conducted on the graphs after adding noise. Among these estimators, they included one for the degree sequence of the graph. Then, noting that an active attacker can indeed profit from this estimator to strengthen the walk-based attack, they show that after increasing the perturbation by a sufficiently small amount this attack also fails. Although the probabilistic attack presented in [33] features some limited level of noise resilience, it is not usable as a general strategy, because it requires the noise to follow a specific distribution and the parameters of this distribution to be known by the adversary. Our definition of robust attack makes no assumptions about the type of perturbation applied to the graph. Finally, we point out that the active attack strategy shares some similarities with graph watermarking methods, e.g. [7, 36, 8]. The purpose of graph watermarking is to release a graph containing embedded instances of a small subgraph, the watermark, that can be easily retrieved by the graph publisher, while remaining imperceptible to others and being hard to remove or distort. Note that the goals of the graph owner and the adversary are to some extent inverted in graph watermarking, with respect to active attacks. Moreover, since the graph owner knows the entire graph, he can profit from this knowledge for building the watermark. During the sybil subgraph creation phase of an active attack, only a partial view of the social graph is available to the attacker. 24 7 Conclusions In this study, we have re-assessed the capabilities of active attackers in the setting of privacy-preserving publication of social graphs. In particular, we have given definitions of robustness for different stages of the active attack strategy and have shown, both theoreti- cally and empirically, scenarios under which these notions of robustness lead to considerably more successful attacks. One particular criticism found in the literature, that of active at- tacks lacking resiliency even to a small number of changes in the network, has been shown in this paper not to be an inherent problem of the active attack strategy itself, but rather of specific instances of it. In light of the results presented here, we argue that active attacks should receive more attention by the privacy-preserving social graph publication community. In particular, existing privacy measures and anonymisation algorithms should be revised, and new ones should be devised, to account for the capabilities of robust active attackers. Acknowledgements: The work reported in this paper received funding from Luxem- bourg's Fonds National de la Recherche (FNR), via grant C17/IS/11685812 (PrivDA). References [1] Lars Backstrom, Cynthia Dwork, and Jon Kleinberg. Wherefore art thou r3579x?: anonymized social networks, hidden patterns, and structural steganography. In Pro- ceedings of the 16th international conference on World Wide Web, WWW '07, pages 181 -- 190, New York, NY, USA, 2007. ACM. [2] Horst Bunke. Recent developments in graph matching. In icpr, page 2117. IEEE, 2000. [3] Jordi Casas-Roma, Jordi Herrera-Joancomart´ı, and Vicen¸c Torra. An algorithm for k-degree anonymity on large networks. In Proceedings of the 2013 IEEE/ACM In- ternational Conference on Advances in Social Networks Analysis and Mining, pages 671 -- 675. ACM, 2013. [4] Jordi Casas-Roma, Jordi Herrera-Joancomart´ı, and Vicen¸c Torra. k-degree anonymity improving data utility in large networks. Knowledge and Infor- and edge selection: mation Systems, 50(2):447 -- 474, 2017. [5] James Cheng, Ada Wai-chee Fu, and Jia Liu. K-isomorphism: privacy preserving net- work publication against structural attacks. In Proceedings of the 2010 ACM SIGMOD International Conference on Management of data, pages 459 -- 470, 2010. [6] Sean Chester, Bruce M Kapron, Ganesh Ramesh, Gautam Srivastava, Alex Thomo, and S Venkatesh. Why waldo befriended the dummy? k-anonymization of social networks with pseudo-nodes. Social Network Analysis and Mining, 3(3):381 -- 399, 2013. 25 [7] Christian Collberg, Stephen Kobourov, Edward Carter, and Clark Thomborson. Error-correcting graphs for software watermarking. In Proceedings of the 29th Work- shop on Graph Theoretic Concepts in Computer Science, pages 156 -- 167. Springer, 2003. [8] David Eppstein, Michael T Goodrich, Jenny Lam, Nil Mamano, Michael Mitzen- In macher, and Manuel Torres. Models and algorithms for graph watermarking. International Conference on Information Security, pages 283 -- 301. Springer, 2016. [9] Thomas Fober, Gerhard Klebe, and Eyke Hullermeier. Local clique merging: An extension of the maximum common subgraph measure with applications in structural bioinformatics. In Algorithms from and for Nature and Life, pages 279 -- 286. Springer, 2013. [10] Michael Hay, Gerome Miklau, David Jensen, Don Towsley, and Philipp Weis. Resist- ing structural re-identification in anonymized social networks. Proc. VLDB Endow., 1(1):102 -- 114, August 2008. [11] Shouling Ji, Weiqing Li, Prateek Mittal, Xin Hu, and Raheem A Beyah. Secgraph: A uniform and open-source evaluation system for graph data anonymization and de- anonymization. In USENIX Security Symposium, pages 303 -- 318, 2015. [12] Changchang Liu and Prateek Mittal. Linkmirage: Enabling privacy-preserving ana- lytics on social relationships. In Procs. of NDSS'16, 2016. [13] Kun Liu and Evimaria Terzi. Towards identity anonymization on graphs. In Proceed- ings of the 2008 ACM SIGMOD International Conference on Management of Data, SIGMOD '08, pages 93 -- 106, New York, NY, USA, 2008. ACM. [14] Xuesong Lu, Yi Song, and St´ephane Bressan. Fast identity anonymization on graphs. In International Conference on Database and Expert Systems Applications, pages 281 -- 295. Springer, 2012. [15] Tinghuai Ma, Yuliang Zhang, Jie Cao, Jian Shen, Meili Tang, Yuan Tian, Abdullah Al-Dhelaan, and Mznah Al-Rodhaan. Kdvem: a k-degree anonymity with vertex and edge modification algorithm. Computing, 97(12):1165 -- 1184, 2015. [16] Sabrine Mallek, Imen Boukhris, and Zied Elouedi. Community detection for graph- based similarity: application to protein binding pockets classification. Pattern Recog- nition Letters, 62:49 -- 54, 2015. [17] Sjouke Mauw, Yunior Ram´ırez-Cruz, and Rolando Trujillo-Rasua. Anonymising social graphs in the presence of active attackers. Transactions on Data Privacy, 11(2):169 -- 198, 2018. 26 [18] Sjouke Mauw, Yunior Ram´ırez-Cruz, and Rolando Trujillo-Rasua. Conditional adja- cency anonymity in social graphs under active attacks. Knowledge and Information Systems, to appear, 2018. [19] Sjouke Mauw, Rolando Trujillo-Rasua, and Bochuan Xuan. Counteracting active attacks in social network graphs. In Proceedings of DBSec'16, volume 9766 of Lecture Notes in Computer Science, pages 233 -- 248, 2016. [20] Prateek Mittal, Charalampos Papamanthou, and Dawn Song. Preserving link privacy in social network based systems. In NDSS 2013, 2013. [21] Arvind Narayanan and Vitaly Shmatikov. De-anonymizing social networks. In Procs. of the 30th IEEE Symposium on Security and Privacy, pages 173 -- 187, 2009. [22] Wei Peng, Feng Li, Xukai Zou, and Jie Wu. Seed and grow: An attack against anonymized social networks. In 9th Annual IEEE Communications Society Conference on Sensor, Mesh and Ad Hoc Communications and Networks, SECON 2012, Seoul, Korea (South), June 18-21, 2012, pages 587 -- 595, 2012. [23] Wei Peng, Feng Li, Xukai Zou, and Jie Wu. A two-stage deanonymization attack against anonymized social networks. IEEE Transactions on Computers, 63(2):290 -- 303, Feb 2014. [24] Fran¸cois Rousseau, Jordi Casas-Roma, and Michalis Vazirgiannis. Community- preserving anonymization of graphs. Knowledge and Information Systems, 54(2):315 -- 343, 2017. [25] Alessandra Sala, Xiaohan Zhao, Christo Wilson, Haitao Zheng, and Ben Y Zhao. Sharing graphs using differentially private graph models. In Procs. of the 2011 ACM SIGCOMM Conf. on Internet Measurement, pages 81 -- 98, 2011. [26] Juli´an Salas and Vicen¸c Torra. Graphic sequences, distances and k-degree anonymity. Discrete Applied Mathematics, 188:25 -- 31, 2015. [27] Pierangela Samarati. Protecting respondents' identities in microdata release. IEEE Trans. on Knowl. and Data Eng., 13(6):1010 -- 1027, 2001. [28] Alberto Sanfeliu and King-Sun Fu. A distance measure between attributed rela- tional graphs for pattern recognition. IEEE Trans. Systems, Man, and Cybernetics, 13(3):353 -- 362, 1983. [29] Latanya Sweeney. k-anonymity: A model for protecting privacy. International Journal of Uncertainty, Fuzziness and Knowledge-Based Systems, 10(5):557 -- 570, 2002. [30] Rolando Trujillo-Rasua and Ismael Gonz´alez Yero. k-metric antidimension: A privacy measure for social graphs. Information Sciences, 328:403 -- 417, 2016. 27 [31] S. Varrette, P. Bouvry, H. Cartiaux, and F. Georgatos. Management of an academic HPC cluster: The UL experience. In Proceedings of the 2014 International Conference on High Performance Computing & Simulation, pages 959 -- 967, Bologna, Italy, 2014. [32] Yazhe Wang, Long Xie, Baihua Zheng, and Ken CK Lee. High utility k-anonymization for social network publishing. Knowledge and information systems, 41(3):697 -- 725, 2014. [33] Mingqiang Xue, Panagiotis Karras, Chedy Raıssi, Panos Kalnis, and Hung Keng Pung. Delineating social network data anonymization via random edge perturbation. In 21st ACM International Conference on Information and Knowledge Management, CIKM'12, Maui, HI, USA, October 29 - November 02, 2012, pages 475 -- 484, 2012. [34] Haifeng Yu, Phillip B Gibbons, Michael Kaminsky, and Feng Xiao. Sybillimit: A near-optimal social network defense against sybil attacks. In Proceedings of the 2008 IEEE Symposium on Security and Privacy, pages 3 -- 17, Oakland, CA, USA, 2008. [35] Haifeng Yu, Michael Kaminsky, Phillip B Gibbons, and Abraham Flaxman. Sybil- guard: defending against sybil attacks via social networks. In Proceedings of the 2006 Conference on Applications, Technologies, Architectures, and Protocols for Computer Communications, pages 267 -- 278, Pisa, Italy, 2006. [36] Xiaohan Zhao, Qingyun Liu, Haitao Zheng, and Ben Y Zhao. Towards graph water- marks. In Proceedings of the 2015 ACM on Conference on Online Social Networks, pages 101 -- 112. ACM, 2015. [37] Bin Zhou and Jian Pei. Preserving privacy in social networks against neighborhood attacks. In Proceedings of the 2008 IEEE 24th International Conference on Data Engineering, ICDE '08, pages 506 -- 515, Washington, DC, USA, 2008. IEEE Computer Society. [38] Lei Zou, Lei Chen, and M. Tamer Ozsu. K-automorphism: A general framework for privacy preserving network publication. Proc. VLDB Endow., 2(1):946 -- 957, August 2009. 28
1809.03020
1
1809
2018-09-09T18:40:15
Development of a Social Network for Research Support and Individual Well-being Improvement
[ "cs.SI", "cs.CY" ]
The ways of communication and social interactions are changing. Web users are becoming increasingly engaged with Online Social Networks (OSN), which has a significant impact on the relationship mechanisms between individuals and communities. Most OSN platforms have strict policies regarding data access, harming its usage in psychological and social phenomena studies, It is also impacting the development of computational methods to evaluate and improve social and individual well-being via the web. Aiming to fill this gap, we propose a platform that brings together social networks dynamics with forum features, altogether with gamification elements, targeting researchers interested in obtaining access to user's data to study psychological and social phenomena.
cs.SI
cs
Development of a Social Network for Research Support and Individual Well-being Improvement Lucas V. A. Caldas Center of Behavioral Theory and Research Federal University of Pará Belém, Brazil [email protected] Antonio F. L. Jacob Jr. Technology Sciences Center State University of Maranhão São Luís, Brazil [email protected] Simone S. C. Silva Center of Behavioral Theory and Research Federal University of Pará Belém, Brazil [email protected] Fernando A. R. Pontes Center of Behavioral Theory and Research Federal University of Pará Belém, Brazil [email protected] Fábio M. F. Lobato Engineering and Geoscience Institute Federal University of Western Pará Santarém, Brazil [email protected] Abstract -- The ways of communication and social interactions are changing drastically. Web users are becoming increasingly engaged with Online Social Networks (OSN), which has a significant impact on the relationship mechanisms between indi- viduals and communities. Most OSN platforms have strict policies regarding data access, harming its usage in psychological and social phenomena studies; It is also impacting the development of computational methods to evaluate and improve social and individual well-being via the web. Aiming to fill this gap, we propose in this paper a platform that brings together social net- works dynamics with forum features, altogether with gamification elements, targeting researchers interested in obtaining access to user's data their investigations. Index Terms -- Online Social Network, Parental Support, Gam- ification, Research Support I. INTRODUCTION Web users are becoming increasingly engaged with Online Social Networks (OSN). Thus, it is perceived a significant expansion of OSN applications boundaries to fields such as academic production, product reputation, human resources management, among others [1]. This phenomenon is related to the spread of Web 2.0, which has consolidated the presence of systems enabling people´s interaction, information sharing, and group formation. Web users are not anymore just infor- mation consumers, once they produce and consume content at the same time, named as "prosumers" [2]. As a consequence, the social capital concept is gaining even more notoriety, which can be defined as a form of economic and cultural capital where social networks play a central role, and in which transactions are marked by reciprocity, trust, and cooperation among agents [3]. In this context, social support via virtual environments arises as users actively post content, get connected with other people and exchange experiences [4], [5]. This support is directly related to the amount of help in those environments. Besides, it can even be obtained through social relationships Accepted at the 2018 IEEE/ACM International Conference on Advances in Social Networks Analysis and Mining (ASONAM 18). For academic purposes, please cite the conference version. to meet different types of need and to support those who are receiving it [6]. In well-established OSNs such as Facebook, social support is provided through communities and direct interactions. However, these communities are often private and have access restrictions. Moreover, it should be noted that, despite the pervasiveness of such platforms, well-established OSN have severe restrictions on access to data due to privacy and information security policies [1]. Such policies make it difficult to use the user-generated content in social science studies, thus, impacting negatively on some understanding of social phenomena. In the light of the foregoing considerations, an International Research Consortium in Social Networks Analysis stated that they need a platform which: i) provides desired features to support social science studies, ii) minimizes access restrictions to user-generated content for academic researchers, and, at the same time, iii) provides an environment to improve individual well-being by inducing the communities formation, and, con- sequently, increasing social capital. Aiming to fill this gap, we present in this paper a platform that mixes network dynamics with forums and gamification elements. It is designed for researchers interested in obtaining access to user data for academic studies, as well as for people interested in sharing their experiences and in building up relationships for mutual support and cooperation. The platform was developed from the perspective of Design Science Research (DSR). Given these aspects, the following Research Questions (RQ) were raised: • RQ1: Is it possible to design a social network platform to support studies on social and psychological phenomena? • RQ2: What is the impact of such platform in the users´ well-being? The remainder of this paper is organized as follows. Section II presents the background of this paper, discussing social networks analysis and its importance to social science studies. The proposed platform is described in Section III. Finally, Section IV concludes this paper and presents future research directions. II. SOCIAL NETWORKS IN SOCIAL SCIENCES RESEARCHES Personal and social networks are essential for exchanging experiences and inducing mutual assistance among their par- ticipants. [7] defines a social network as a system composed of several participants, which have functions and activities applied to an interaction context. In other words, is a set of actors (individuals) and their connections (relation- ships). These networks can be categorized considering the environment where social in-person or virtual environment, for instance. In this sense, groups and communities are formed in a way that there are information sharing and people integration [8], [9]. These are peculiar features existing in social support networks, where interactions tend to be mutually beneficial to its participants, and may also be the result of the friendship acquisition [10]. interactions occur: it The lack of social capital is common to people who experi- ence situations that lead them away from social environments, which is the case of relatives of people with disabilities [11]. In several areas, it is observed that the induction of a social support network in OSN enables a more pervasive and effective formation of virtual communities for mutual support [12]. The supportive interactions in users groups can be predicted through logs analysis of systems usage. For instance, [13] has analyzed posts, clicks and page ladings made by Reddit users. As a result, the authors have measured what they called "interaction success" of users posts. This information can be used to recommend posts/content that is more relevant to each kind of user. In another point of view, [14] has analyzed an in-person social network, modeling it as a virtual environment. To do so, the authors modelled a network structure to identify the public participation in the management of protected areas, such as the Iron Gates Natural Park (Romanian). The data collected allowed the authors to build a graph corresponding to the social network interactions. As a result, the authors per- ceived that the networks for protected area management have weak connections between its nodes, and that they are very decentralized. Thus, this finding has justified the necessity to improve the collaboration between the people involved in this process. In other perspective, [11] studied adolescent mothers from Western Australia. The authors became aware that the easy access to information through existing communities in virtual social networks has contributed to the increase in the sense of trust, competence, and responsibility. Also, the use of networks softens the sense of social isolation through the re-engagement of these users in their social circles. These are just a few examples of virtual network analysis and its relevance for social science studies. Even though, many more applications could be targeted in this context if researchers could have full access to the user-generated content and related data. In this sense, an International Research Consortium in Social Networks Analysis, formed by research centers in Sociology, Psychology, Nursing, Economics and Computing, stated a necessity for a platform with free and complete access to data, considered crucial to increase the impact of the actions and studies conducted. This consortium is composed by several research groups and laboratories, with international cooperation, the main partners in Brazil are: The Federal University of Pará is represented by the Computa- tional Intelligence Laboratory1 and the Development Ecology Laboratory2, the latter involves researchers from psychology, occupational therapy and sociology; The NeuroRehab group is representing University of São Paulo3; The Federal University of Minas Gerais is participating with the Interdisciplinary Research Group in Social Network Analysis4; and the Federal University of Western Pará, through the Applied Computing Research Group5. The major international cooperation came from the Social CRM Research Center of the Universität Leipzig6 and the Center for Counseling and Therapy from the Universität Dortmund7. Some of the investigations conducted by this consortium include the use of social networks (virtual and face-to-face) for parental support to families with relatives with disabilities; innovation and collaboration ecosystems; and social customer relationship management OSN. In the light of the given scenario, the next section presents the proposed platform. III. RESULTS The artifact was developed under Design Science Research methodology, which is a well-accepted approach in infor- mation systems research projects when the final goal is the development of a product, strategies, and services. According to [15], the DSR is a process model composed of six sequential steps, which are: i) problem identification and motivation; ii) definition of solution objectives; iii) project and development; iv) demonstration; v) evaluation; and vi) communication. The Figure 1 shows the DSR elements for the present project. The aforementioned research consortium required a plat- form that would provide features usually not found in well- established social networks. Considering that the system should have the flexibility to be applied in different contexts, the project guidelines were defined in meetings with stake- holders from the consortium to ensure the attendance of all their needs. So, the following guidelines were established: 1) ease of navigation; 2) responsiveness; 3) information security; 4) flexibility and extensibility; and 5) user engagement. The architecture of the network developed was based on the Model-View-Controller (MVC) pattern, to meet the guideline 3. Guidelines 1 and 2 were used and applied in the View layer, while the others were implemented in the Model layer because they were business rules or non-functional security 1http://www.linc.ufpa.br/ 2http://www.ufpa.br/led/ 3http://gruposdepesquisa.eerp.usp.br/sites/neurorehab/ 4http://www.giars.ufmg.br/ 5dgp.cnpq.br/dgp/espelhogrupo/2969843796195905 6http://www.scrc-leipzig.de/ 7https://www.fk-reha.tu-dortmund.de/zbt/de/home/index.html COMPARISONS BETWEEN MAIN FUNCTIONALITIES OF THE MOST USED NETWORKS AND THE PROPOSED NETWORK. TABLE I Functionalities Open Login Create Communities Survey Gamification Profile Customization Chat Video Events Lives Post Documents (PDF) Profile Restrictions Unrestricted Data Acess m e t s y S d e s o p o r P (cid:88) × (cid:88) (cid:88) (cid:88) (cid:88) (cid:88) (cid:88) × × × (cid:88) k o o b e c a F r e t t i w T e b u t u o Y p p a s t a h W (cid:88) (cid:88) (cid:88) × (cid:88) (cid:88) (cid:88) × (cid:88) (cid:88) (cid:88) × (cid:88) × × × (cid:88) × (cid:88) × × × (cid:88) × (cid:88) × × × (cid:88) × (cid:88) × (cid:88) (cid:88) (cid:88) × (cid:88) (cid:88) × × (cid:88) (cid:88) (cid:88) (cid:88) × × (cid:88) × Fig. 1. Instantiation of the DSR elements of the development of the proposed platform. requirements (guideline 3). There was also a concern with bandwidth consumption, considering that a significant part of the users would access the platform by mobile devices. It has also motivated the implementation of some strategies to decrease bandwidth consumption in the controller layer. The platform was developed in PHP programming language, using the CodeIgniter framework, the database was implemented using MySQL and the responsiveness was implemented using Bootstrap. Finally, to ease the user experience, the system was inspired by popular networks such as Facebook, Twitter, and Orkut. Thereby, many of the proposed platform features have been inspired by features that already exist in other networks, but with several elements mixed, providing a differential from the already existing systems. For instance, one of these unique features is the possibility of posting PDF documents. In Table I we can see a comparative overview of the main features of the proposed system and some of the most used networks. There are two types of users´ on the platform: Moderators and Ordinary users. Moderators are users with special priv- ileges. For example, they are responsible for managing the network communities. Another point that deserves attention is the merging of social networking elements with forums at- tributes. This concept was integrated into the platform through a discussion system inside the communities. Therefore, communities were designed to work as chat that groups, where each community represents a subject can be divided into smaller and more specific discussions. For instance, in a system development context, we could have the following communities: "Programming Language", "Database" and "Software Engineering´´. Thus, discussions are smaller topics within a community subject and are also the place where users interact with each other to talk about that topic. In the "Programming Language" community, we could have discussions named "PHP", "JAVA" and "C++". Ordinary users are not allowed to create new communities, once each community needs a moderator, and this function is only given to a person who detains some knowledge about the community subject. However, any user may create discussions, and by doing so, they propose new themes and keep the community alive. Communities also have a survey application system, which works as a quick way of understanding the opinion of members through small questions with multiple choice and predefined answers. This mechanism was added to support researchers in survey applications. Thinking about encouraging users participation in these questions, they were incorporated into the platform gamifica- tion mechanism, also to meet guideline 5. Software gamifica- tion is a technique that seeks to reduce failures, increase func- tionality and engagement. However, misapplication and lack of intimacy with the gamification process design can make it a big enemy, leading to very high risks for a software that may lead to its failure [16], [17]. The main gamification elements adopted were points, levels, rankings, medals/achievements, integration, engagement loops, and reinforcement and feed- back rules. These elements have unique characteristics and distinct purposes. Among these, we highlight the engagement loops, which are bonuses and missions that arouse the user's interest in reusing the system, which is directly related to a motivational feeling. The gamification elements were applied to the network structure through a reward system based on actions performed by users, such as liking and sharing posts, answering surveys and posting activities. Each action is considered to raise the user level, and each level unlocks a medal. The difficulty of obtaining the next medals is computed as an arithmetic progression, that always adds twice the amount of experience to go to the next level. The network has a total of nine medals. Some desired features such as "lives" and "events" were not added yet. However, strategies for inclusion of these features are already being studied. Besides that, it is worth mentioning that the unrestricted data access is available only to the researchers who use the platform as a tool for research support and that sign a compromise term. The platform terms of use describe that user data can be used in scientific studies. By accepting it, the user is granting permission to use their data in such research projects. IV. FINAL REMARKS Online Social Networks had revolutionized social science studies. These platforms represent a new communication chan- nel and a relevant data source about individual's behavior and desires. However, those platforms lack some features such as community creation, possibility to apply surveys or to share documents, for instance. Moreover, most large-scale studies face a critical barrier regarding restrictions on data access. In the light of the foregoing considerations, an International Research Consortium stated a need regarding a platform that provides desired features to support social science studies and minimizes access restrictions to user-generated content for academic researchers. In this paper, we have tackled these issues by developing a general purpose social network that brings together social networks dynamics, forum features and gamification elements; targeting researchers interested in obtaining access to users´ data to study psychological and social phenomena. To do so, Design Science Research was adopted as a methodology to conduct the present study. it Retaking the research questions stated before, and ana- lyzing the results, is possible to answer them. For the RQ1, considering the preliminary results and the researchers' expectations, the answer is yes, it is possible to use such kind of platform. Besides, its usage is not restricted only to academia, but also able to be applied to industry as well. One application glimpsed was to promote innovation ecosystems in medium companies. Regarding RQ2, the platform features, more specifically the forums with moderator and the gamifica- tion strategies, have helped to improve the information quality across the network, but more analysis should be performed. Considering these results, for future work, more case studies should be conducted and quantitative evaluation should be performed to assess researcher´s and volunteer´s satisfaction. ACKNOWLEDGEMENTS This research was supported by the National Council for the Na- the Improvement of Higher Education (CAPES); tional Council for Scientific and Technological Development (CNPq); and Amazon Foundation for Studies and Research (Fapespa); all of them are Brazilian. REFERENCES [1] F. Lobato, M. Pinheiro, A. Jacob, O. Reinhold, and Á. Santana, "Social CRM: Biggest Challenges to Make it Work in the Real World," in Business Information Systems Workshops: BIS 2016 International Work- shops, Leipzig, Germany, July 6-8, 2016, Revised Papers, W. Abramow- icz, R. Alt, and B. Franczyk, Eds. Cham: Springer International Publishing, 2017, vol. 263, pp. 221 -- 232. [2] G. Ritzer and N. Jurgenson, "Production, Consumption, Prosumption: The nature of capitalism in the age of the digital 'prosumer'," Journal of Consumer Culture, vol. 10, no. 1, pp. 13 -- 36, Mar. 2010. [3] P. S. Adler and S.-W. Kwon, "Social capital: Prospects for a new concept," Academy of Management Review, vol. 27, no. 1, pp. 17 -- 40, 2002. [4] R. M. Smedley, N. S. Coulson, J. Gavin, K. Rodham, and L. Watts, "Engagement in a newly launched online support community for com- plex regional pain syndrome: Membership growth, header analysis and introductory messages," Int. J. Web Based Communities, vol. 12, no. 2, pp. 147 -- 164, Jan. 2016. [5] R. Smedley, N. Coulson, J. Gavin, K. Rodham, and L. Watts, "Online social support for complex regional pain syndrome: A content analysis of support exchanges within a newly launched discussion forum," Computers in Human Behavior, vol. 51, pp. 53 -- 63, 2015. [6] D. G. Rand, S. Arbesman, and N. A. Christakis, "Dynamic social net- works promote cooperation in experiments with humans," Proceedings of the National Academy of Sciences, vol. 108, no. 48, pp. 19 193 -- 19 198, 2011. [7] V. Donmus, "The use of social networks in educational computer-game based foreign language learning," Procedia - Social and Behavioral Sciences, vol. 9, pp. 1497 -- 1503, 2010, world Conference on Learning, Teaching and Administration Papers. [8] Y.-S. Wei, H. Chu, C.-H. Chen, Y.-J. Hsueh, Y.-S. Chang, L.-I. Chang, and K.-R. Chou, "Support groups for caregivers of intellectually disabled family members: effects on physical -- psychological health and social support," Journal of Clinical Nursing, vol. 21, no. 11-12, pp. 1666 -- 1677, feb 2012. [9] W. Silva, Á. Santana, F. Lobato, and M. Pinheiro, "A Methodology for Community Detection in Twitter," in Proceedings of the International Conference on Web Intelligence, 2017, pp. 1006 -- 1009. [10] N. T. M. Thuy and H. L. Berry, "Social capital and mental health among mothers in Vietnam who have children with disabilities," Global Health Action, vol. 6, p. 10.3402/gha.v6i0.18886, feb 2013. [11] S. Nolan, J. Hendricks, and A. Towell, "Social networking sites (SNS); exploring their uses and associated value for adolescent mothers in Western Australia in terms of social support provision and building social capital," Midwifery, vol. 31, no. 9, pp. 912 -- 919, sep 2015. [12] H. J. Oh, E. Ozkaya, and R. LaRose, "How does online social network- ing enhance life satisfaction? the relationships among online supportive interaction, affect, perceived social support, sense of community, and life satisfaction," Computers in Human Behavior, vol. 30, pp. 69 -- 78, 2014. [13] M. Glenski and T. Weninger, "Predicting user-interactions on reddit," in Proceedings of the 2017 IEEE/ACM International Conference on Advances in Social Networks Analysis and Mining 2017, ser. ASONAM '17. New York, NY, USA: ACM, 2017, pp. 609 -- 612. [14] A. Nita, C. M. Ciocanea, S. Manolache, and L. Rozylowicz, "A social network approach to diagnose public participation in protected areas management: Insights from a natura 2000 case study," in Proceedings of the 2017 IEEE/ACM International Conference on Advances in Social Networks Analysis and Mining 2017, ser. ASONAM '17. New York, NY, USA: ACM, 2017, pp. 771 -- 774. [15] K. Peffers, T. Tuunanen, M. Rothenberger, and S. Chatterjee, "A design science research methodology for information systems research," J. Manage. Inf. Syst., vol. 24, no. 3, pp. 45 -- 77, 2007. [16] B. Morschheuser, L. Hassan, K. Werder, and J. Hamari, "How to design gamification? a method for engineering gamified software," Information and Software Technology, vol. 95, pp. 219 -- 237, 2018. [17] S. Deterding, R. Khaled, L. Nacke, and D. Dixon, "Gamification: Toward a Definition," in CHI 2011 Gamification Workshop Proceedings, Vancouver, BC, Canada, 2011.
1812.11448
6
1812
2019-03-29T00:59:54
Removing Malicious Nodes from Networks
[ "cs.SI", "cs.LG" ]
A fundamental challenge in networked systems is detection and removal of suspected malicious nodes. In reality, detection is always imperfect, and the decision about which potentially malicious nodes to remove must trade off false positives (erroneously removing benign nodes) and false negatives (mistakenly failing to remove malicious nodes). However, in network settings this conventional tradeoff must now account for node connectivity. In particular, malicious nodes may exert malicious influence, so that mistakenly leaving some of these in the network may cause damage to spread. On the other hand, removing benign nodes causes direct harm to these, and indirect harm to their benign neighbors who would wish to communicate with them. We formalize the problem of removing potentially malicious nodes from a network under uncertainty through an objective that takes connectivity into account. We show that optimally solving the resulting problem is NP-Hard. We then propose a tractable solution approach based on a convex relaxation of the objective. Finally, we experimentally demonstrate that our approach significantly outperforms both a simple baseline that ignores network structure, as well as a state-of-the-art approach for a related problem, on both synthetic and real-world datasets.
cs.SI
cs
Removing Malicious Nodes from Networks Yevgeniy Vorobeychik Sixie Yu Computer Science and Engineering Washington University in St. Louis [email protected] Computer Science and Engineering Washington University in St. Louis [email protected] 9 1 0 2 r a M 9 2 ] I S . s c [ 6 v 8 4 4 1 1 . 2 1 8 1 : v i X r a ABSTRACT A fundamental challenge in networked systems is detection and removal of suspected malicious nodes. In reality, detection is al- ways imperfect, and the decision about which potentially malicious nodes to remove must trade off false positives (erroneously remov- ing benign nodes) and false negatives (mistakenly failing to remove malicious nodes). However, in network settings this conventional tradeoff must now account for node connectivity. In particular, ma- licious nodes may exert malicious influence, so that mistakenly leaving some of these in the network may cause damage to spread. On the other hand, removing benign nodes causes direct harm to these, and indirect harm to their benign neighbors who would wish to communicate with them. We formalize the problem of remov- ing potentially malicious nodes from a network under uncertainty through an objective that takes connectivity into account. We show that optimally solving the resulting problem is NP-Hard. We then propose a tractable solution approach based on a convex relaxation of the objective. Finally, we experimentally demonstrate that our approach significantly outperforms both a simple baseline that ig- nores network structure, as well as a state-of-the-art approach for a related problem, on both synthetic and real-world datasets. ACM Reference Format: Sixie Yu and Yevgeniy Vorobeychik. 2019. Removing Malicious Nodes from Networks. In Proc. of the 18th International Conference on Autonomous Agents and Multiagent Systems (AAMAS 2019), Montreal, Canada, May 13 -- 17, 2019, IFAAMAS, 10 pages. 1 INTRODUCTION The problem of removing malicious nodes from networks has long been of considerable importance, and it has attracted a great deal of recent attention. In social networks, accounts occupied by malicious parties spread toxic information (e.g., hate speech, fake news, and spam), stirring up controversy and manipulating political views among social network users [1, 6]. Major social media entities, such as Facebook, have devoted considerable effort on identifying and removing fake or malicious accounts [16, 17]. Despite these efforts, there is evidence that the problem is as prevalent as ever [2, 14]. A similar challenge obtains in cyber-physical systems (e.g., smart grid infrastructure), where computing nodes compromised by malware can cause catastrophic losses [13], but removing non-malicious nodes may cause power failure [22]. A common thread in these scenarios is the tradeoff faced in deciding which nodes to remove: removing a benign node (false positive) causes damage to this node, which may be inconvenience or loss of productivity, and potentially also results in indirect losses Proc. of the 18th International Conference on Autonomous Agents and Multiagent Systems (AAMAS 2019), N. Agmon, M. E. Taylor, E. Elkind, M. Veloso (eds.), May 13 -- 17, 2019, Montreal, Canada. © 2019 International Foundation for Autonomous Agents and Multiagent Systems (www.ifaamas.org). All rights reserved. to its neighbors; on the other hand, failing to remove a malicious node (false negative) can have deliterious effects as malicious influ- ence spreads to its neighbors. The key observation is that the loss associated with a decision whether to remove a node depends both on the node's likelihood of being malicious and its local network structure. Consequently, the typical approach in which we simply classify nodes as malicious or benign using a threshold on the as- sociated maliciousness probability [8] is inadequate, as it fails to account for network consequences of such decisions. Rather, the problem is fundamentally about choosing which subset of nodes to remove, as decisions about removing individual nodes are no longer independent. We consider the problem of choosing which subset of nodes to remove from a network given an associated probability distribution over joint realizations of all nodes as either malicious or benign (that is, we allow probability that node i is malicious to depend on whether its neighbors are malicious, as in collective classification and relational learning [12, 19]). We then model the problem as minimizing expected loss with respect to this distribution, where the loss function is composed of three parts: the direct loss (L1) stemming from removed benign nodes, the indirect loss associated with cutting links between removed and remaining benign nodes (L2), and the loss associated with malicious nodes that remain, quantified in terms of links these have to benign nodes (L3). Figure 1: An illustration of a decision to remove two nodes, Jack and Emma, from the network, on our loss function. To illustrate, consider Figure 1. In this example, we have decided to remove, Jack and Emma, the two benign nodes on the right of the vertical dotted line. On the other hand, we chose not to remove the malicious node in red. Suppose that we pay a penalty of α1 for each benign node we remove, a penalty of α2 for each link we cut between two benign nodes, and α3 for each link between remaining malicious and benign nodes. Since we removed 2 benign nodes (L1 = 2), cut 2 links between benign nodes (one between Jack and Nancy, and another between Emma and Rachel; L2 = 2), and the malicious node is still connected to 5 benign nodes (Tom, Duke, Ryna, Rachel, and Nancy; L3 = 5), our total loss is 2α1 + 2α2 + 5α3. If we instead only removed the malicious node, our total loss would have been 0, while removing the malicious node instead of Emma (but together with Jack) would result in the loss of α1 + 2α2. As minimizing our loss function is intractable, we resort to its convex relaxation. We solve the convex relaxation for a globally op- timal solution, and then convert it to an approximate solution to the original problem by Euclidean projection. Extensive experiments demonstrate that our approach is better than the baseline which treats nodes as independent, and both better and significantly more scalable than a state of the art approach for a related problem. In summary, our contributions are: (1) a model that captures both direct and indirect effects of mistakes in removing benign and malicious nodes from the network, (2) an algorithm based on convex relaxation for computing an approximately optimal solution to our problem, and (3) extensive experimental evaluation of our approach on both synthetic and real-world data. Related Work. There are several prior efforts dealing with a re- lated problem of graph scan statistics and hypothesis testing [3, 15, 18]. These approaches focus on the following scenario. We are given a graph G where each node in the graph is associated with a random variable. The null hypothesis is that these random vari- ables are sampled from the standard Gaussian distribution N(0, 1), while the alternative hypothesis is that there is a fraction of nodes (malicious nodes) where the random variables associated with them are sampled from a Gaussian distribution N(µ, 1) with µ other than 0. A scan statistics T is defined, which can be thought as a function defined over random variables associated with a subset of nodes. Then the hypothesis test is equivalent to maximizing T over subset of nodes, and the null hypothesis is rejected if strong evidence exists (i.e. large value of T ). Arias-Castro et al. [3] proposed a scan statistic for special graph models. Priebe et al. [15] proposed a scan statistic defined over clus- ters with special geometric structures. These methods do not easily generalize to arbitrary graph models or arbitrary scan statistics. Sharpnack et al. [18] employed the generalized log-likelihood ratio as the scan statistic. By assuming that the set of malicious nodes has sparse connections with others, the hypothesis test can be con- verted to solving a graph cut problem, which is further relaxed into a convex optimization by leveraging the Lovász extension of a graph cut. Our problem can be formulated as a hypothesis testing problem. A random variable associated with each node indicates whether it's malicious or not, with associated maliciousness probability. Com- puting a set of malicious nodes is then equivalent to searching for a subset of nodes that maximizes the graph scan statistic T , which provides the strongest evidence to reject the null hypothesis. However, there are several problems with this formulation. First, in our setting we are not solely concerned about direct loss (wrongly removing benign nodes or wrongly keeping malicious nodes), but also the indirect loss, for example, the number of edges that have been cut between benign nodes, which is diffcult to capture using a single graph scan statistic (i.e. generalized log-likelihood ratio). Sec- ond, hypothesis testing with graph scan statistics usually requires one to solve a combinatorial optimization problem that has an expo- nentially large search space. Consequently, it is typically necessary to assume special structure about the problem (i.e. Sharpnack et al. [18] assumed small cut-size). In contrast, our proposed approach considers direct and indirect loss associated with mistakes, and makes no assumptions about graph structure. 2 MODEL We consider a social network that is represented by a graph G = (V , E), where V is the set of nodes (V = N) and E the set of edges connecting them. Each node i ∈ V represents a user and each edge (i, j) represents an edge (e.g., friendship) between users i and j. For simplicity, we focus our discussion on undirected graphs, although this choice is not consequential for our results. We denote the adjacency matrix of G by A ∈ RN×N . The elements of A are either 1/0 if the graph is unweighted, or some non-negative real numbers if the graph is weighted. Again, we simplify exposition by focusing on unweighted graphs; generalization is direct. We consider the problem of removing malicious nodes from the network G. We explain the problem by first considering complete information about the identity of malicious and benign nodes, and subsequently describe our actual model in which this information is unknown (as this in fact is the crux of our problem). Specifically, let π ∈ {0, 1}N be a configuration of the network, with πi = 1 indicating that a node i is malicious, with πi = 0 when i is benign. For convenience, we also define ¯πi = 1 − πi that indicates whether i is benign. Consequently, π (and ¯π) assigns a malicious or benign label to every node. Let the malicious and benign nodes be denoted by V + and V −, respectively. Our goal is to identify a subset of nodes S to remove in order to minimize the impact of the remaining malicious nodes on the network, while at the same time minimizing disruptions caused to the benign subnetwork. To formalize this intuition, we define a loss function associated with the set S of nodes to remove. This loss function has three components, each corresponding to a key consideration in the problem. The first part of the loss function, L1 = V − ∩ S, is the direct loss associated with removing benign nodes; this simply penalizes every false positive, as one would naturally expect, but ignores the broken relationships among benign nodes that result from our decision. That is captured by the second component, L2 = {(i, j)i ∈ (V − ∩ (V \ S)) , j ∈ (V − ∩ S) ,∀i, j ∈ V }, which imposes a penalty for cutting connections between benign nodes that are removed and benign nodes that remain. In other words, the second loss component captures the indirect consequence of removing be- nign nodes on the structure of the benign subnetwork. This aspect is critical to capture in network settings, as relationships and con- nectivity are what networks are about. The third component of the loss function, L3 =(cid:12)(cid:12){(i, j)i ∈(cid:0)V + ∩ (V \ S)(cid:1) , j ∈ (V − ∩ (V \ S))}(cid:12)(cid:12), measures the consequence of failing to remove malicious nodes in terms of connections from these to benign nodes. At the high level, this part of the loss naturally captures the influence that unremoved malicious nodes can exert on the benign part of the network. The total loss combines these three components as a weighted sum, L = α1L1 + α2L2 + α3L3, with α1 + α2 + α3 = 1. Other than this constraint, we allow αis to be arbitrary relative weights of the different components, specified depending on the domain. For ex- ample, if we are concerned about false positives, but not very much about network structure, we would set α1 ≫ α2. Alternatively, we can set these coefficients to normalize the relative magnitudes of the loss terms (for example, setting α1 = 1 ). N We now rewrite the loss function in a way that will prove more mathematically convenient. Let s ∈ {0, 1}N , where si = 1 if and only if node i is removed (i ∈ S), and, for convenience, let ¯s = 1 − s, where ¯si = 1 if node i remains in the network (i ∈ V \ S). Then, the loss associated with (s, ¯s) is L(π , s, ¯s) := and α2 = α3 = N−1 2N N (cid:124)(cid:32)(cid:32)(cid:32)(cid:123)(cid:122)(cid:32)(cid:32)(cid:32)(cid:125) si ¯πi i =1 L1 N (cid:124)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:123)(cid:122)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:125) Ai, jsi ¯sj ¯πi ¯πj i, j L2 N (cid:124)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:123)(cid:122)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:125) ¯si ¯sjAi, j πi ¯πj i, j L3 α1 +α2 +α3 . (1) With complete information, it is immediate that the loss is min- imized if S contains all, and only, the malicious nodes. Our main challenge is to solve this problem when the identity of malicious and benign nodes is uncertain, and instead we have a probability distribution over these. This probability distribution may capture any prior knowledge, or may be obtained by learning probability that a node is malicious given its features from past data. To formal- ize, let π ∼ P, where P captures the joint probability distribution over node configurations (malicious or benign). For our purposes, we make no assumptions on the nature of this distribution; a spe- cial case would be when maliciousness probabilities for nodes are independent (conditional on a node's observed features), but our model also captures natural settings in which configurations of network neighbors are correlated (e.g., when malicious nodes tend to have many benign neighbors). Our expected loss that we aim to minimize then becomes L(s, ¯s) := N (cid:21) si ¯πi + α2 Ai, jsi ¯sj ¯πi ¯πj + α3 ¯si ¯sjAi, j πi ¯πj i, j i =1 si Eπ∼P[ ¯πi] + α2 i, j Ai, jsi ¯sj Eπ∼P[ ¯πi ¯πj] N N i, j N (cid:20) N α1 i =1 Eπ∼P = α1 N i, j + α3 ¯si ¯sjAi, j Eπ∼P[πi ¯πj]. (2) While we will assume that we know P in the remaining technical discussion, we relax this assumption in our experimental evaluation, where we also demonstrate that our approach is quite robust to errors in our estimation of P. In order to have a concise representation of our objective, we convert Eq. (2) to a matrix-vector form. Note that the configuration π of network is a random variable distributed according to P. We let µ ∈ RN×1 and Σ ∈ RN×N denote its mean and covariance, respectively. For convenience we let J(n, m) ∈ Rn×m denote a matrix with all elements equal to one with dimensions determined by the arguments n and m. We define a diagonal matrix B ∈ RN×N , where the diagonal entries are equal to Eπ∼P[ ¯π] = 1 − µ. Note that 1 ∈ RN×1 is a vector with all elements equal to one. We define another matrix P := A⊙Eπ∼P[ ¯π ¯πT ], where the operator ⊙ denotes Hadamard product. By replacing ¯π with 1 − π and leveraging the linearity of expectation we have: P :=A ⊙ Eπ∼P[ ¯π ¯πT ] =A ⊙ Eπ∼P[(1 − π)(1 − π)T ] =A ⊙ Eπ∼P[11T ] − Eπ∼P[1πT ] − Eπ∼P[π1T ] + Eπ∼P[ππT ] J(N , N) − J(N , 1) × µT − µ × J(1, N) + Σ + µ × µT . =A ⊙ (cid:19) (cid:18) (cid:18) (cid:19) Similarly we define M := A ⊙ Eπ∼P[π ¯πT ]. Then we have M : = A ⊙ Eπ∼P[π ¯πT ] = A ⊙ Eπ∼P[π(1 − π)T ] (cid:18) = A ⊙ µ × J(1, N) − Σ − µ × µT . We can now rewrite Eq. (2) in a matrix-vector form: L(s, ¯s) := α11T Bs + α2 sT P1 − sT Ps + α3¯sT M ¯s. (cid:19) (cid:19) (cid:18) 3 SOLUTION APPROACH The problem represented by Eq. (5) is a non-convex quadratic inte- ger optimization problem, which is difficult to solve directly. Indeed, we show that our problem is NP-Hard. To begin, we re-arrange the terms in Eq. (5), which results in: (3) (4) (5) (6) (7) min s sT A1s + sT b1 + c1 s ∈ {0, 1}N s.t . where A1, b and c1 are: A1 =α3M − α2P b1 =α1BT 1 + α2P1 − α3M1 − α3MT 1 c1 =α31T M1. Since Eq. (6) is equivalent to Eq. (5), we prove the NP-hardness of minimizing Eq. (6). Theorem 3.1. Solving Problem (6) is NP-Hard. Proof. We construct the equivalence between a special case of the model defined in Eq. (6) and the Maximum Independent Set (MIS) problem . Given a graph G = (V , E), the MIS problem is to find an independent set in G of maximum cardinality, which is NP-hard to solve. We specify the special case by considering a specific form of the loss function defined in Eq. (2) where: (1) α2 = 0, (2) Eπ∼P[πi] = Eπ∼P[ ¯πi] = 1 (3) πi and πj are independent random variables for any i (cid:44) j, (4) α3 > 2α1M, where M is a large positive number. which means Eπ∼P[πi ¯πj] = 1 2 ,∀i = 1, . . . , N , which leads to the follwing loss: 4 ,∀i (cid:44) j. N (cid:124)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:123)(cid:122)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:125) Aij ¯si ¯sj i, j + α3 4 . L† 2 N (cid:124)(cid:32)(cid:32)(cid:32)(cid:32)(cid:123)(cid:122)(cid:32)(cid:32)(cid:32)(cid:32)(cid:125) si i =1 L† 1 L† = α1 2 Denote the nodes in the maximum independent set of G as K. We first show that keeping only the nodes in K is the optimal solution. Note that removing any node from K increases the loss, by incurring α12 losses added to L† 1. Next we denote V ′ = V \K, which is the set of nodes removed from the graph. we show that putting any set of nodes in V ′ back to K increases the loss. Suppose we put a set of nodes B ⊆ V ′ back to K. This must introduce additional edges to K, otherwise K is not the maximum independent set. Let the number of additionally introduced edges be C. Putting B back to K decreases L† 2. The net change of L† is: 1. however, it increases L† − α1 2 B + α3 2 C, which is always positive because α3 > 2α1M. Since we cannot remove or add any set of nodes to K without increasing L†, keeping only the nodes in K is the optimal solution. For the other direction, we show that if keeping the nodes in a set K minimizes the loss, then K is the maximum independent set of G. First, suppose K is not an independent set, which means there is at least one edge in K. Then removing one or both of the endpoints always decrease the loss because α3 > 2α2M. Intuitively, the loss of removing a benign node from G is way less than the loss of leaving a malicious edge in G. So K must be an independent set. Next, we show K is the maximum independent set. Suppose another set K′ is the maximum independent set and K′ > K. Then keeping the nodes in K′ can further decrease L† by decreasing L† 1, which contradicts the fact that keeping the nodes in K minimizes the loss. Therefore we conclude K is the maximum independent set. □ Our approach to solving Eq. (6) is by means of a convex relax- ation, as we now describe. Note that the matrix A1 in Eq. (6) is not symmetric. We substitute A1 with Q := A1+AT12 2b1, which results in an equivalent problem: and b := 1 min s s.t . sT Qs + 2sT b + c1 s ∈ {0, 1}N (8) where Q ∈ SN×N is a real symmetric matrix. Directly minimizing Eq. (8) is still intractable, and we instead derive its convex relaxation into a Semidefinite Program (SDP). We solve the convex relaxation for a global optimum. The objective value associated with the global optimum gives a lower bound to the objective value of Eq. (8). Next, we convert the global optimum to a feasible solution of Eq. (8). In what follows, we first derive an intermediate problem, which is a relaxation (not necessarily convex) of Eq. (8). This intermediate problem plays the role of a bridge between Eq. (8) and its convex relaxation due to several of its nice properties, which we will de- scribe shortly. Based on the properties of the intermediate problem we derive its convex relaxation, which is also a convex relaxation of Eq. (8). To derive the intermediate problem, we first relax Eq. (8) by expanding its feasible region. The original feasible region of Eq. (8) is the set of vertices of a hypercube. We expand the original feasible region to the entire hypercube, which is defined by C = {s0 ⪯ s ⪯ 1, s ∈ RN }. We further expand C to the circumscribed sphere of the hypercube, which results in C = {s(s− 1 2 1) ≤ N4 , s ∈ RN }. After the successive expansion we have the following Quadratically 2 1)T (s− 1 Constrained Quadratic Programming (QCQP), which was previously dubbed as the "intermediate problem": min s s.t . sT Qs + 2sT b + c1 (s − 1 2 1)T (s − 1 2 1) ≤ N 4 . (9) The problem Eq. (9) is still non-convex, since in our problem setting the matrix Q is usually not positive (semi-)definite. How- ever, Eq. (9) offers several benefits. First, it is a QCQP with only one inequality constraint, which indicates that it has a convex dual problem and under mild conditions (Slater's condition) strong dual- ity holds [5]. This suggests that we can find the global optimum of a non-convex problem (when Slater's conditions hold) by solving its dual problem. Second, applying duality theory twice on Eq. (9) results in its own convex relaxation, which is therefore the convex relaxation of Eq. (8). In what follows we thereby derive the convex relaxation of Eq. (9). We first obtain the Lagrangian l(s, λ) of Eq. (9) as follows, where λ ≥ 0 is a Lagrangian multiplier: l(s, λ) :=sT Qs + 2bT s + c1 + λ(cid:2)(s − 1 (cid:3) 2 1)T (s − 1 2 1) − N 4 =sT (Q + λI)s + (2b − λ1)T s + c1. The dual function д(λ) is then д(λ) = inf (cid:40) s = l(s, λ) c1 − (b − λ2 1)T (Q + λI)†(b − λ2 1), −∞, cond1 o.w. (10) (11) where (Q + λI)† is the Pseudo-Inverse of (Q + λI). Note that cond1 consists of two conditions: first, that Q +λI is positive semi-definite and second, that b − λ2 1 lies in the column space of Q + λI. If the conditions in cond1 are satisfied, maximizing д(λ) is feasible and the primal problem is bounded. Otherwise, д(λ) is unbounded below (−∞), and we have a certificate that the primal problem in Eq. (9) is also unbounded. With cond1 satisfied, we introduce a variable γ as the lower bound of д(λ), which indicates c1 − (b − λ2 1)T (Q + λI)†(b− λ2 1) ≥ γ. Then maximizing д(λ) is equivalent to maximizing γ. Further, by Schur Complement (and remember (Q + λI) ⪰ 0), the inequality c1 − (b − λ2 1)T (Q + λI)†(b − λ2 1) ≥ γ is equivalently represented by a linear matrix inequality b − λ2 1 c1 − γ (cid:20) Q + λI (b − λ2 1)T ⪰ 0, (cid:21) which enables us to represent the dual problem of Eq. (9) as a Semidefinite Program (SDP) with two variables, γ and λ: max γ ,λ s.t . γ λ ≥ 0 (cid:20) Q + λI (b − λ2 1)T (cid:21) ⪰ 0, b − λ2 1 c1 − γ (12) As discussed above, applying duality theory twice to Eq. (9) results in its own convex relaxation. Consequently, we continue to derive the dual of Eq. (12). The Lagrangian l(γ , λ, S, s, α) of Eq.(12) (cid:21) s 1 ⪰ 0 and sT (cid:20) S (cid:21)(cid:19) is calculated as follows, where S ∈ SN , s ∈ RN , α ≥ 0 are Lagrangian multipliers: tr s 1 sT · · · (b − λ2 1)T (cid:21)(cid:20) S b − λ2 1 c1 − γ l(γ , λ, S, s, α) = − γ − λα − tr = −γ − λα− (cid:18)(cid:20) Q + λI (cid:18)(cid:20)(Q + λI)S + (b − λ2 1)sT (cid:21)(cid:19) (cid:124)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:123)(cid:122)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:32)(cid:125) = λ(cid:2) − α − tr(S) + 1T s(cid:3) −(cid:2)tr(QS) + 2bT s + c1(cid:3), where tr(·) is trace operator. Notice that λ(cid:2) − α − tr(S) + 1T s(cid:3) is a (b − λ2 1)T s + c1 − γ We only need to keep these block matrices on the diagonal linear function of λ, so [−α −tr(S) +1T s] must be zero, as otherwise the linear function can be minimized without bound. In addition, the Lagrangian multiplier α is greater than or equal to zero, so from −α − tr(S) + 1T s = 0 we have tr(S) − 1T s ≤ 0, which is denoted by cond2. The dual function д(S, s) is then: (13) · · · д(S, s) = inf γ ,λ,α l(γ , λ, S, s, α) (cid:40)−tr(QS) − 2bT s − c1, = −∞, cond2 o.w. The dual problem of Eq. (12) is the minimization of −д(S, s), which can be represented as a SDP as follows: (14) (15) min S ∈SN ,s ∈RN s.t . tr(QS) + 2bT s + c1 tr(S) − 1T s ≤ 0 ⪰ 0, (cid:20) S (cid:21) s 1 sT (cid:20) S sT (cid:21) ⪰ 0 s 1 In order to see the connections between Eq. (15) and Eq. (9), we first note that by Schur Complement the linear matrix inequality is equivalent to S ⪰ ssT . Therefore if we reduce the feasible region of Eq. (15) by enforcing the equality constraint S = ssT , and then utilize that and tr(QS) = tr(QssT ) = sT Qs 2 1)T (s − 1 tr(S) − 1T s ≤ 0 ≡ (s − 1 2 1) ≤ N 4 , we have an equivalent problem to Eq. (9). This shows that Eq. (15) is a convex relaxation of Eq. (9) and, therefore, a convex relaxation of Eq. (6). We solve Eq.(15) for a global optimal solution, which is denoted by (S∗, s∗). Then we apply Euclidean projection to convert s∗ to a feasible solution of Eq. (6), which is denoted by ¯s∗. We remove all nodes from the network with ¯s∗ i > 0.5. We call our full algorithm MINT (Malicious In NeTwork), which is detailed in Algorithm 1: Next we show with appropriate choice of the trade-off parame- ters the optimal value of Eq. (8) is upper- and lower-bounded by the optimal value of Eq. (15), which provides performance guarantee Algorithm 1 MINT 1: Input: Q, b, c1 2: Compute the global optimal solution s∗ of Eq. (15) 3: Solve ¯s∗ = arg mins ∈C s − s∗2 4: Remove all nodes with ¯s∗ i ≥ 0.5 for the SDP relaxation. We denote the optimal objective value of the originally intractable optimizatioin by V∗ and the optimal objective value of the SDP relaxation by P∗ . Then we have the following theorem: SDP Theorem 3.2. When the (i, j)-th element of the matrix Q in Eq. (8) satisfying qij ≥ 0,∀i (cid:44) j, the optimal objective value V∗ is upper- and lower-bounded by the optimal objective value P∗ SDP up to a constant β: P∗ SDP ≤ V∗ ≤ P∗ SDP + β Proof. The proof is deferred to the Appendix. □ To understand the relation between the condition qij ≥ 0,∀i (cid:44) j and the choice of the trade-off parameters, we first note that ∀i (cid:44) j: qij = (α2 + α3)(cid:0) µi + µj − E[µi µj](cid:1) − α2, where µi is the maliciousness probability of the i-th node. Then qij ≥ 0 is equivalent to: µi + µj α2 2 ≥ E[µi µj] + α2 + α3 ,∀i (cid:44) j. 2 The left-hand side of Eq. (16) consists of the maliciousness prob- abilities estimated from data, which can be thought as constants when we analyze the the behavior of the inequality. When E[µi µj] is large, the edge (i, j) is more likely to be a connection between a malicious node and a benign node, which means we would like a small α2 that encourages cutting connections. Notice that a small α2 is exactly what we need to make the inequality in Eq. (16) hold. Therefore the condition qij ≥ 0,∀i (cid:44) j indicates that the choice of the trade-off paramters is important to guarantee the performance of the SDP relaxation. (16) 4 EXPERIMENTS In this section we present experiments to show the effectiveness of our approach. We considered both synthetic and real-world network structures, but in all cases derived distribution over maliciousness of nodes P using real data. For synthetic network, we considered two types of network structures: Barabasi-Albert (BA) [4] and Watts- Strogatz networks (Small-World) [21]. BA is characterized by its power-law degree distribution, where the probability that a ran- domly selected node has k neighbors is proportional to k−r . For both networks we generated instances with N = 128 nodes. For real-world networks, we used a network extracted from Facebook data [10] which consisted of 4039 nodes and 88234 edges. We ex- perimented with randomly sampled sub-networks with N = 500 nodes. In our experiments, we consider a simplified case where the maliciousness probabilities for nodes are independent. In addition, we assume that a single estimator (e.g., logistic regression) was trained to estimate the probability that a node is malicious based on features from past data. Note that these assumptions are reasonable for the purpose of validating the effectiveness of our model, since the focus of our model is not how to estimate maliciousness proba- bilities. For more complex cases, for example, when maliciousness probabilities for nodes are correlated, more advanced techniques, such as Markov Random Fields, can be applied to estimate the maliciousness probabilities, but our general approach would not change. In all of our experiments, we derived P from data as follows. We start with a dataset D which includes malicious and benign instances (the meaning of these designations is domain specific), and split it into three subsets: Dtr ain (the training set), D1, and D2, with the ratio of 0.3 : 0.6 : 0.1. Our first step is to learn a probabilis- tic predictor of maliciousness as a function of a feature vector x, p(x), on Dtr ain. Next, we randomly assign malicious and benign feature vectors from D2 to the nodes on the network, assigning 10% of nodes with malicious and 90% with benign feature vectors. For each node, we use its assigned feature vector x to obtain our estimated probability of this node being malicious, p(x); this gives us the estimated maliciousness probability distribution P. This is the distribution we use in MINT and the baseline approaches. How- ever, to ensure that our evaluation is fair and reasonably represents realistic limitations of the knowledge of the true maliciousness dis- tribution, we train another probabilistic predictor, p(x), now using Dtr ain ∪ D1. Applying this new predictor to the nodes and their assigned feature vectors, we now obtain a distribution P∗ which we use to evaluate performance. We conducted two sets of experiments. In the first set of ex- periments we used synthetic networks and used data from the Spam [11] dataset to learn the probabilistic maliciousness model p(x), and thereby derive P. The Spam dataset D consists of spam and non-spam instances along with their corresponding labels. In the second set of experiments we used real-world networks from Facebook and used Hate Speech data [7] collected from Twit- ter to obtain P as discussed above. The Hate Speech dataset is a crowd-sourced dataset that contains three types of tweets: 1. hate speech tweets that express hatred against a targeted group of peo- ple; 2. offensive language tweets that appear to be rude, but do not explicitly promote hatred; and 3. normal tweets that neither pro- mote hatret nor are offensive. We categorized this dataset into two classes in terms of whether a tweet represents Hate Speech, with the offensive language tweets categorized as non-Hate Speech. After categorization, the total number of tweets is 24783, of which 1430 are Hate Speech. We applied the same feature extraction techniques as Davidson et al. [7] to process the data. Note that our second set of experiments makes use of real data for both the network and the node maliciousness distribution P. Moreover, as noted by Waseem and Hovy [20], hate speech is wide- spread among Facebook users, and our second set of experiments can be viewed as studying the problem of identifying and poten- tially removing nodes from a social network who egregiously spew hate. Baselines. We compared our algorithm (MINT) with LESS, a state-of-the-art approach for graph hypothesis testing, and a simple baseline which removes a node i if its maliciousness probability pi > θ∗, where θ∗ is a specified threshold. The algorithm LESS was proposed in Sharpnack et al. [18], and considers a related hypothesis testing problem. The null hypothesis is that each node in the graph is associated with a random variable sampled from the standard Gaussian N(0, 1), while the alternative hypothesis is that there is a fraction of nodes where the random variables associated with them are sampeld from N(µ, 1) with µ other that 0 (in our interpretation, these are the malicious nodes). The algorithm LESS employs the generalized log-likelihood over a subset of nodes as a test statistic, and the hypothesis test is to find the subset that has the strongest evidence aginst the null hypothesis. We remove the subset of nodes found by LESS. The simple baseline has a trade-off parameter α between false- positive rate (FPR) and false-negative rate (FNR) (in our experiments α = 0.5). We select an optimal threshold θ∗ that minimizes αF PR + (1 − α)F N R on training data. 1 3 , Experiment Results. The averaged losses for our first set of experi- ments where P was simulated from Spam data are shown in Table 1. The top table contains the results on BA networks and the bottom table contains the results on Small-World networks. Each row cor- responds to a combination of trade-off parameters (α1, α2, α3); for example, (0.1, 0.2, 0.7) corresponds to (α1 = 0.1, α2 = 0.2, α3 = 0.7). We experimented with four combinations of these: (0.1, 0.2, 0.7), (0.2, 0.7, 0.1), (0.7, 0.2, 0.1), and ( 1 3). Each number was ob- 1 3 , tained by averaging over 50 randomly generated network topolo- gies. Table 1 shows that MINT has the lowest loss across all settings except (0.1, 0.2, 0.7). To delve into the results more, we present the box plots for the experimental results on BA networks in Figure 2. Note that as Table 1 indicates that LESS performs considerably worse than both MINT and, remarkably, even the simple baseline across all combinations of the trade-off parameters, and we omit its box plots. Just as we observed in the table, three of the four box plots show a substantial improvement of MINT over the baseline in three out of the four cases, with the lone exception being when the trade- off parameters are (0.1, 0.2, 0.7), that is, when the importance of preserving links among benign nodes is relatively low. In this case, it is reasonable to expect that the value of considering the network topology is dominated by the first-order considerations of removing malicious nodes and keeping benign, already largely captured by our simple baseline. Thus, our machinery is unnecessary in such a case, as its primary value is when overall connectivity of the benign subnetwork is also a first-order consideration, as we expect it to be in social network settings. This value is borne out by the results in the three remaining plots in Figure 2, where the baseline clearly underperforms MINT. An interesting observation is that in the upper right and lower left cases the average losses of MINT are close to 0, which is actually the best value that the loss function in Eq.(6) can achieve. Considering that minimizing Eq.(6) is a NP-hard problem, our convex relaxation gives a high quality approximation in polynomial time. 1 The box plots for the experimental results on Small-World net- works are shown in Figure 3, where we now include LESS as it is more competitive in this case. The overall trend is similar to Fig- ure 2. Moreover, the box plots reveal that, while MINT is better than the simple baseline that ignores network structure in the three of 1Solving the SDP relaxation Eq. (15) is in polynomial-time with interior-point method (0.1,0.2,0.7) (0.2,0.7,0.1) (0.7,0.2,0.1) (1/3,1/3,1/3) BA Baseline 7.8403 14.6207 6.7699 5.8533 Small-World Baseline LESS 28.6337 82.0922 32.2678 44.1410 LESS 12.5336 4.0273 4.3518 7.4027 MINT 16.9782 1.8650 1.5342 4.3730 MINT 24.7706 2.9719 1.8324 4.8369 (0.1,0.2,0.7) (0.2,0.7,0.1) (0.7,0.2,0.1) (1/3,1/3,1/3) 8.7965 20.0915 8.2982 7.4418 Table 1: Experiments where P and P∗ were simulated from Spam data. the four cases where network structure matters the most, its pefor- mance appears comparable to LESS on average, but exhibits much less variance than LESS. This may be attributed to the fact that both MINT and LESS are approximately solving hard optimization problems, and the MINT algorithm consistently arrives at a good approximation of the optimal solution, while the approximation quality of LESS is more variable. In any case, this is particularly noteworthy given the fact that MINT dramatically outperforms LESS in terms of scalability, as we show below. Figure 3: Experimental results on Small-World networks, where P and P∗ were simulated from Spam data. The aver- aged losses are reported in Table 1. Upper Left: (0.1, 0.2, 0.7); Upper Right: (0.2, 0.7, 0.1); Lower Left: (0.7, 0.2, 0.1); Lower Right: ( 1 3 , 3). Each plot was averaged over 50 runs. 1 1 3 , The results demonstrate that MINT again significantly outperforms the baseline in all but one case in which the importance of cutting malicious links greatly outweighs other considerations. Note that when keeping benign nodes connected becomes more important than removing malicious nodes (e.g., when the trade-off parameters are (0.2, 0.7, 0.1) and (0.7, 0.2, 0.1)), MINT surpasses the baseline by nearly an order of magnitude, which confirms that a simple baseline that trades off between false-positive rate and false-negative rate is not enough to take indirect harm into account. Again, we present the comparison in greater depth using box plots in Figure 4. The overall trend is similar to other two boxplots. There is, however, one distinctive obervation that the dispersion of losses on Facebook networks is larger than the dispersion on BA networks. This observation likely results from the fact that the SDP relaxation Eq. (15) for Facebook networks is substantially looser than that for BA networks in the sense that it has more variables and constraints, which makes locating the exact optimal solution of Eq. (15) harder. Indeed, we were using interior-point method to solve Eq. (15) and there were a few cases where the maximum number of iterations was reached while the optimal solution had not been found. In any case, we still consistently observe performance improvement compared to the baseline even as we take this variance into account. Figure 2: Experimental results on BA networks, where P and P∗ were simulated from Spam data. The averaged losses are reported in Table 1. Upper Left: (0.1, 0.2, 0.7); Upper Right: (0.2, 0.7, 0.1); Lower Left: (0.7, 0.2, 0.1); Lower Right: ( 1 3). 1 3 , Each plot was averaged over 50 runs. 1 3 , Next, we evaluate the performance of MINT in our second set of experiments which use real data for both the network topol- ogy and to derive the maliciousness distribution (the latter using the Hate Speech dataset). In this case, LESS does not scale to the problem sizes we consider, and we only compare MINT to the sim- ple baseline. The average losses are shown in Table 2, where each number was averaged over 50 randomly sampled sub-networks. MINTbaseline1015LossMINTbaseline1020LossMINTbaseline2468LossMINTbaseline456LossMINTbaselineLESS102030LossMINTbaselineLESS1020LossMINTbaselineLESS1020LossMINTbaselineLESS5101520Loss Recall that while MINT assumes knowledge of the distribution P, our evaluation above used a simulated ground-truth distribution P∗, thereby capturing the realistic consideration that MINT would be applied using an estimated, rather than actual, distribution. Nev- ertheless, we now study the sensitivity of MINT to estimation error more systematically. Specifically, we added Gaussian noise N(0, σ) to each estimated malicious probability pi, which results in P. We varied σ from 0.1 to 0.5. Then we ran MINT on P and evaluated it on P∗. We used Spam data to simulate P and P∗, and conducted ex- periments on BA and Small-World network structures. We focused on a specific setting where (α1 = 0.1, α2 = 0.2, α3 = 0.7). Other combinations of weight parameters generated similar results. The results on BA networks (Figure 6 Left) show that perfor- mance of MINT does not significantly degrade even as we introduce a substantial amount of noise, which indicats that MINT is robust against estimation error. The results on Small-World networks, on the other hand, do show that MINT exhibits some degradation with increasing σ. However, even in this case degradation is relatively slow. Altogether, our experiments suggest that MINT is quite robust to estimation error. Figure 6: Sensitivity analysis of MINT. Each bar was aver- aged over 15 runs. Left: BA. Right: Small-World 5 CONCLUSION We considered the problem of removing malicious nodes from a network under uncertainty. We designed a model (loss function) that considers both the likelihood that a node is malicious, as well as the network structure. Our key insight is for the loss function to capture both the direct loss associated with false positives and the indirect loss associated with cutting connections between benign nodes, and failing to cut connections from malicious nodes to their benign network neighbors. We first showed that this optimization problem is NP-Hard. Nevertheless, we proposed an approach based on convex relaxation of the loss function, which is quite tractable in practice. Finally, we experimentally showed that our algorithm outperforms alternative approaches in terms of loss, including both a simple baseline that trades off only the direct loss (false positives and false negatives) and a state-of-the-art approach, LESS, which uses a graph scan statistic. Moreover, our method is significantly faster than the LESS algorithm. ACKNOWLEDGEMENT This research was partially supported by the National Science Foun- dation (IIS-1905558) and Army Research Office (W911NF-16-1-0069 and MURI W911NF-18-1-0208). Figure 4: Experimental results on Facebook networks, where P and P∗ were simulated from Spam data. The aver- aged losses are reported in Table 1. Upper Left: (0.1, 0.2, 0.7); Upper Right: (0.2, 0.7, 0.1); Lower Left: (0.7, 0.2, 0.1); Lower Right: ( 1 3 , 3). Each plot was averaged over 50 runs. 1 1 3 , (0.1,0.2,0.7) (0.2,0.7,0.1) (0.7,0.2,0.1) (1/3,1/3,1/3) Baseline MINT 56.1550 44.2784 128.1051 41.7881 60.7507 5.9065 72.3060 39.5743 Table 2: Experiments where P and P∗ were simulated from Hate Speech data, using Facebook network data. All the dif- ferences are significant. Figure 5: Running time averaged over 15 trials. Left: BA, Right: Small-World. Next, we compare the running time of LESS and MINT as a function of the number of nodes on the network in Figure 5 for the case where α1 = α2 = α3 = 1 3; alternatives generated similar results. Each point in Figure 5 was averaged over 15 trials. The experiments were conducted on a desktop (OS: Ubuntu 14.04; CPU: Intel i7 4GHz 8-core; Memory: 32GB). We can see that MINT is significantly faster than LESS, with the difference increasing in the network size. Indeed, LESS becomes impractical for realistic network sizes, whereas MINT remains quite scalable. MINTbaseline4060LossMINTbaseline0100200LossMINTbaseline0255075LossMINTbaseline50100Loss163248648096112128#nodes0100200300400secondsMINTLESS163248648096112128#nodes0100200300400secondsMINTLESS0.10.20.30.40.501020304050Loss0.10.20.30.40.501020304050Loss APPENDIX Proof of Theorem 3.2 SDP Proof. It is direct to show P∗ SDP ≤ V∗, since Eq.(15) is the dual of Eq.(12) which is the dual of Eq. (9). Our main focus is to prove V∗ ≤ P∗ + β. Notice that we have: V∗ ≤ E(cid:2)sT Qs + 2sT b + c1(cid:3), (17) which is true by taking expectations in both sides of V∗ ≤ sT Qs + 2sT b +c1 which holds since by definition V∗ is the optimal objective value of the right-hand side. Then we apply the randomization procedure introduced in [9] to sample feasible solutions for Eq. (8). Specifically, solving Eq. (15) results in a positive-semidefinite matrix S∗. We define ¯S∗ = (S∗ + I), which is a positive-definite matrix. By the Cholesky decomposition of ¯S∗ we have: We normalize each column of V to have unit length, which results in a set of vectors v1, · · · , vN : = vT is the ij-th element of ¯S∗. Now Note that ¯S∗ ij we randomly sample s ∈ {0, 1}N , where the i-th element of s is generated as follow: i vj, where ¯S∗ (cid:3) , vi2 = 1∀i ∗ = V T V . ¯S V =(cid:2)v1, · · · , vN (cid:40)1, vT ij si = i z > 0 i z ≤ 0. 0, vT The random vector z ∈ RN is sampled from a Gaussian distribution, 2 1, I), where I is the identity matrix in RN×N . The expec- z ∼ N( 1 tation of si is 0.5, since the probabilities of vT i z < 0 are equal to 0.5, respectively. We let µ denote the expectation of s, so µ = 1 i z ≥ 0 and vT 2 1. The covariance matrix Σ of the random vector s is: Σ = E(cid:2)(s − µ)(s − µ)T(cid:3) where J(N , N) ∈ RN×N is a matrix with all elements equal to 1. Notice that the (i, j)-th element of the expectation E[ssT ] is E[sisj], which is equal to the probability that both si and sj are equal to 1: Following the similar argument as Lemma 2.2 of [9] we know: = E[ssT ] − µµT = E[ssT ] − 1 4 J(N , N), P(cid:0)vT = P(cid:0)vT E[sisj] = P(si = 1, sj = 1) i z > 0, vT j z > 0(cid:1). j z > 0(cid:1) = π − θ i z > 0, vT 2π i vj). Therefore we have: E[sisj] = , 1 2 − θ 2π i vj) 2 − arccos(vT 1 2π 2 − arccos( ¯S∗ ij) 2π 1 . = = where θ = arccos(vT 1 4 1T Q1 1 4 1T Q1 1 4 1T Q1 1 4 1T Q1 1 4 1T Q1 Now we expand the Eq. (17) as the following: = tr + 1T b + c1 + qij Σji + 1T b + c1 + V∗ ≤ E(cid:2)sT Qs + 2sT b + c1(cid:3) 2 1) + 2sT 1 + c1(cid:3) + = E(cid:2)(s − 1 2 1)T(cid:1)(cid:3) + 1T b + c1 + = E(cid:2)tr(cid:0)Q(s − 1 2 1)T Q(s − 1 2 1)T(cid:3)(cid:19) (cid:18) 2 1)(s − 1 QE(cid:2)(s − 1 2 1)(s − 1 = tr(cid:0)QΣ(cid:1) + 1T b + c1 + = 1 4 1T Q1 = (cid:0)E[sisj] − 1 = (cid:0) 1 4 − arccos( ¯S∗ ij) (∗)≤ ∗ ¯S ij + 1T b + c1 + = = tr(cid:0)QS (cid:1) + 1T b + c1 + (cid:1) + 1T b + c1 + (the diagonal elements of Q are zeros) 1 4 1T Q1 1 4 1T Q1 1 4 1T Q1 2π qij qij qij i, j i, j i, j i, j 4 i, j qijS ∗ ∗(cid:1) + 1T b + c1 + ij + 1T b + c1 + 1 4 1T Q1, where (∗) is true because the inequality: 4 − arccos(x) ≤ x 2π holds on 0 ≤ x ≤ 1 and qij ≥ 0,∀i, j. Since: 1 P∗ SDP ≤ V∗ ≤ tr(cid:0)QS β ≥(cid:2)tr(cid:0)QS ∗(cid:1) + 1T b + c1 + ∗(cid:1) + 1T b + c1 + 4 1T Q1(cid:3) − P∗ 1 1 4 1T Q1, SDP we select a nonnegative constant β such that: = 1T b + 1 4 1T Q1 − 2bT s ∗ , (18) where s∗ is the optimal solution of Eq. (15). Note that since the elements of b and Q are bounded, we can always find such a β. With β we have: V∗ ≤ tr(cid:0)QS ≤ tr(cid:0)QS ∗(cid:1) + 1T b + c1 + ∗(cid:1) + 2bT s ∗ + c1 + β 1 4 1T Q1 = P∗ + β, SDP which completes the proof. □ REFERENCES [1] Hunt Allcott and Matthew Gentzkow. Social media and fake news in the 2016 election. Journal of Economic Perspectives, 31(2):211 -- 36, 2017. [2] Vinicius Andrade. Facebook, whatsapp step up efforts in brazil's fake news battle. Bloomberg. URL https://www.bloomberg.com/news/articles/2018-10-23/ facebook-whatsapp-step-up-efforts-in-brazil-s-fake-news-battle. [3] Ery Arias-Castro, Emmanuel J Candes, and Arnaud Durand. Detection of an anomalous cluster in a network. The Annals of Statistics, pages 278 -- 304, 2011. [4] Albert-László Barabási and Réka Albert. Emergence of scaling in random net- works. science, 286(5439):509 -- 512, 1999. university press, 2004. [5] Stephen Boyd and Lieven Vandenberghe. Convex optimization. Cambridge [6] Justin Cheng, Cristian Danescu-Niculescu-Mizil, and Jure Leskovec. Antisocial behavior in online discussion communities. In ICWSM, pages 61 -- 70, 2015. [7] Thomas Davidson, Dana Warmsley, Michael Macy, and Ingmar Weber. Automated hate speech detection and the problem of offensive language. arXiv preprint arXiv:1703.04009, 2017. [8] Charles Elkan. The foundations of cost-sensitive learning. In International joint conference on artificial intelligence, volume 17, pages 973 -- 978. Lawrence Erlbaum Associates Ltd, 2001. [9] Michel X Goemans and David P Williamson. Improved approximation algorithms for maximum cut and satisfiability problems using semidefinite programming. Journal of the ACM (JACM), 42(6):1115 -- 1145, 1995. [10] Jure Leskovec and Julian J Mcauley. Learning to discover social circles in ego networks. In Advances in neural information processing systems, pages 539 -- 547, 2012. [11] Moshe Lichman et al. Uci machine learning repository, 2013. [12] Sofus A. Macskassy and Foster Provost. Classification in networked data: A toolkit and a univariate case study. Journal of Machine Learning Research, 8: 935 -- 983, 2007. [13] Yilin Mo, Tiffany Hyun-Jin Kim, Kenneth Brancik, Dona Dickinson, Heejo Lee, Adrian Perrig, and Bruno Sinopoli. Cyber -- physical security of a smart grid infrastructure. Proceedings of the IEEE, 100(1):195 -- 209, 2012. [14] Vidya Narayanan, Vlad Barash, John Kelly, Bence Kollanyi, Lisa-Maria Neudert, and Philip N Howard. Polarization, partisanship and junk news consumption over social media in the us. arXiv preprint arXiv:1803.01845, 2018. [15] Carey E Priebe, John M Conroy, David J Marchette, and Youngser Park. Scan statistics on enron graphs. Computational & Mathematical Organization Theory, 11(3):229 -- 247, 2005. Facebook suspends 115 accounts for 'inauthentic be- URL https://www.politico.com/story/2018/11/06/ [16] Jesus Rodriguez. havior' as polls open. facebook-suspends-accounts-polls-2018-964325. [17] Shane Scott and Mike Isaac. Facebook says it's policing fake accounts. but they're still easy to spot. The New York Times. URL https://www.nytimes.com/2017/11/ 03/technology/facebook-fake-accounts.html. [18] James L Sharpnack, Akshay Krishnamurthy, and Aarti Singh. Near-optimal anomaly detection in graphs using lovasz extended scan statistic. In Advances in Neural Information Processing Systems, pages 1959 -- 1967, 2013. [19] Ben Taskar, Vassil Chatalbashev, and Daphne Koller. Learning associative markov networks. In Proceedings of the Twenty-first International Conference on Machine Learning, 2004. [20] Zeerak Waseem and Dirk Hovy. Hateful symbols or hateful people? predictive features for hate speech detection on twitter. In Proceedings of the NAACL student research workshop, pages 88 -- 93, 2016. [21] Duncan J Watts and Steven H Strogatz. Collective dynamics of small-world networks. nature, 393(6684):440, 1998. determine large network cascades in power grids. Science, 358(886), 2017. [22] Yang Yang, Takashi Nishikawa, and Adilson E. Motter. Small vulnerable sets
1702.01119
1
1702
2017-02-03T19:00:03
Anyone Can Become a Troll: Causes of Trolling Behavior in Online Discussions
[ "cs.SI", "cs.CY", "cs.HC", "stat.AP" ]
In online communities, antisocial behavior such as trolling disrupts constructive discussion. While prior work suggests that trolling behavior is confined to a vocal and antisocial minority, we demonstrate that ordinary people can engage in such behavior as well. We propose two primary trigger mechanisms: the individual's mood, and the surrounding context of a discussion (e.g., exposure to prior trolling behavior). Through an experiment simulating an online discussion, we find that both negative mood and seeing troll posts by others significantly increases the probability of a user trolling, and together double this probability. To support and extend these results, we study how these same mechanisms play out in the wild via a data-driven, longitudinal analysis of a large online news discussion community. This analysis reveals temporal mood effects, and explores long range patterns of repeated exposure to trolling. A predictive model of trolling behavior shows that mood and discussion context together can explain trolling behavior better than an individual's history of trolling. These results combine to suggest that ordinary people can, under the right circumstances, behave like trolls.
cs.SI
cs
Anyone Can Become a Troll: Causes of Trolling Behavior in Online Discussions Justin Cheng1, Michael Bernstein1, Cristian Danescu-Niculescu-Mizil2, Jure Leskovec1 1Stanford University, 2Cornell University {jcccf, msb, jure}@cs.stanford.edu, [email protected] 7 1 0 2 b e F 3 ] I S . s c [ 1 v 9 1 1 1 0 . 2 0 7 1 : v i X r a ABSTRACT In online communities, antisocial behavior such as trolling disrupts constructive discussion. While prior work suggests that trolling behavior is confined to a vocal and antisocial minority, we demonstrate that ordinary people can engage in such behavior as well. We propose two primary trigger mechanisms: the individual's mood, and the surrounding con- text of a discussion (e.g., exposure to prior trolling behavior). Through an experiment simulating an online discussion, we find that both negative mood and seeing troll posts by others significantly increases the probability of a user trolling, and together double this probability. To support and extend these results, we study how these same mechanisms play out in the wild via a data-driven, longitudinal analysis of a large online news discussion community. This analysis reveals temporal mood effects, and explores long range patterns of repeated exposure to trolling. A predictive model of trolling behavior shows that mood and discussion context together can explain trolling behavior better than an individual's history of trolling. These results combine to suggest that ordinary people can, under the right circumstances, behave like trolls. ACM Classification Keywords H.2.8 Database Management: Database Applications-Data Mining; J.4 Computer Applications: Social and Behavioral Sciences Author Keywords Trolling; antisocial behavior; online communities INTRODUCTION As online discussions become increasingly part of our daily interactions [24], antisocial behavior such as trolling [37, 43], harassment, and bullying [82] is a growing concern. Not only does antisocial behavior result in significant emotional dis- tress [1, 58, 70], but it can also lead to offline harassment and threats of violence [90]. Further, such behavior comprises a substantial fraction of user activity on many web sites [18, 24, 30] – 40% of internet users were victims of online ha- rassment [27]; on CNN.com, over one in five comments are removed by moderators for violating community guidelines. What causes this prevalence of antisocial behavior online? Permission to make digital or hard copies of all or part of this work for personal or classroom use is granted without fee provided that copies are not made or distributed for profit or commercial advantage and that copies bear this notice and the full cita- tion on the first page. Copyrights for components of this work owned by others than ACM must be honored. Abstracting with credit is permitted. To copy otherwise, or re- publish, to post on servers or to redistribute to lists, requires prior specific permission and/or a fee. Request permissions from [email protected]. CSCW 2017, February 25–March 1, 2017, Portland, OR, USA. Copyright is held by the owner/author(s). Publication rights licensed to ACM. ACM ISBN 978-1-4503-4189-9/16/10 ...$15.00. http://dx.doi.org/10.1145/2998181.2998213 In this paper, we focus on the causes of trolling behavior in discussion communities, defined in the literature as behavior that falls outside acceptable bounds defined by those commu- nities [9, 22, 37]. Prior work argues that trolls are born and not made: those engaging in trolling behavior have unique personality traits [11] and motivations [4, 38, 80]. However, other research suggests that people can be influenced by their environment to act aggressively [20, 41]. As such, is trolling caused by particularly antisocial individuals or by ordinary people? Is trolling behavior innate, or is it situational? Like- wise, what are the conditions that affect a person's likelihood of engaging in such behavior? And if people can be influ- enced to troll, can trolling spread from person to person in a community? By understanding what causes trolling and how it spreads in communities, we can design more robust social systems that can guard against such undesirable behavior. This paper reports a field experiment and observational anal- ysis of trolling behavior in a popular news discussion com- munity. The former allows us to tease apart the causal mech- anisms that affect a user's likelihood of engaging in such be- havior. The latter lets us replicate and explore finer grained aspects of these mechanisms as they occur in the wild. Specif- ically, we focus on two possible causes of trolling behavior: a user's mood, and the surrounding discussion context (e.g., seeing others' troll posts before posting). Online experiment. We studied the effects of participants' prior mood and the context of a discussion on their likelihood to leave troll-like comments. Negative mood increased the probability of a user subsequently trolling in an online news comment section, as did the presence of prior troll posts writ- ten by other users. These factors combined to double partici- pants' baseline rates of engaging in trolling behavior. Large-scale data analysis. We augment these results with an analysis of over 16 million posts on CNN.com, a large online news site where users can discuss published news articles. One out of four posts flagged for abuse are authored by users with no prior record of such posts, suggesting that many un- desirable posts can be attributed to ordinary users. Support- ing our experimental findings, we show that a user's propen- sity to troll rises and falls in parallel with known population- level mood shifts throughout the day [32], and exhibits cross- discussion persistence and temporal decay patterns, suggest- ing that negative mood from bad events linger [41, 45]. Our data analysis also recovers the effect of exposure to prior troll posts in the discussion, and further reveals how the strength of this effect depends on the volume and ordering of these posts. Drawing on this evidence, we develop a logistic regression model that accurately (AUC=0.78) predicts whether an indi- vidual will troll in a given post. This model also lets us eval- uate the relative importance of mood and discussion context, and contrast it with prior literature's assumption of trolling being innate. The model reinforces our experimental findings – rather than trolling behavior being mostly intrinsic, such behavior can be mainly explained by the discussion's context (i.e., if prior posts in the discussion were flagged), as well as the user's mood as revealed through their recent posting his- tory (i.e., if their last posts in other discussions were flagged). Thus, not only can negative mood and the surrounding dis- cussion context prompt ordinary users to engage in trolling behavior, but such behavior can also spread from person to person in discussions and persist across them to spread fur- ther in the community. Our findings suggest that trolling, like laughter, can be contagious, and that ordinary people, given the right conditions, can act like trolls. In summary, we: • present an experiment that shows that both negative mood and discussion context increases the likelihood of trolling, • validate these findings with a large-scale analysis of a large • use these insights to develop a predictive model that sug- online discussion community, and gests that trolling may be more situational than innate. BACKGROUND To begin, we review literature on antisocial behavior (e.g., aggression and trolling) and influence (e.g., contagion and cascading behavior), and identify open questions about how trolling spreads in a community. Antisocial behavior in online discussions Antisocial behavior online can be seen as an extension of sim- ilar behavior offline, and includes acts of aggression, harass- ment, and bullying [1, 43]. Online antisocial behavior in- creases anger and sadness [58], and threatens social and emo- tional development in adolescents [70]. In fact, the pain of verbal or social aggression may also linger longer than that of physical aggression [16]. Antisocial behavior can be commonly observed in online public discussions, whether on news websites or on social media. Methods of combating such behavior include com- ment ranking [39], moderation [53, 67], early troll identifica- tion [14, 18], and interface redesigns that encourage civility [51, 52]. Several sites have even resorted to completely dis- abling comments [28]. Nonetheless, on the majority of pop- ular web sites which continue to allow discussions, antisocial behavior continues to be prevalent [18, 24, 30]. In particular, a rich vein of work has focused on understanding trolling on these discussion platforms [26, 37], for example discussing the possible causes of malicious comments [55]. A troll has been defined in multiple ways in previous lit- erature – as a person who initially pretends to be a legiti- mate participant but later attempts to disrupt the community [26], as someone who "intentionally disrupts online commu- nities" [77], or "takes pleasure in upsetting others" [47], or more broadly as a person engaging in "negatively marked on- line behavior" [37] or that "makes trouble" for a discussion forums' stakeholders [9]. In this paper, similar to the latter studies, we adopt a definition of trolling that includes flam- ing, griefing, swearing, or personal attacks, including behav- ior outside the acceptable bounds defined by several commu- nity guidelines for discussion forums [22, 25, 35].1 In our experiment, we code posts manually for trolling behavior. In our longitudinal data analysis, we use posts that were flagged for unacceptable behavior as a proxy for trolling behavior. Who engages in trolling behavior? One popular recurring narrative in the media suggests that trolling behavior comes from trolls: a small number of particularly sociopathic indi- viduals [71, 77]. Several studies on trolling have focused on a small number of individuals [4, 9, 38, 80]; other work shows that there may be predisposing personality (e.g., sadism [11]) and biological traits (e.g., low baseline arousal [69]) to ag- gression and trolling. That is, trolls are born, not made. Even so, the prevalence of antisocial behavior online suggests that these trolls, being relatively uncommon, are not respon- sible for all instances of trolling. Could ordinary individuals also engage in trolling behavior, even if temporarily? People are less inhibited in their online interactions [84]. The rela- tive anonymity afforded by many platforms also deindividu- alizes and reduces accountability [95], decreasing comment quality [46]. This disinhibition effect suggests that people, in online settings, can be more easily influenced to act anti- socially. Thus, rather than assume that only trolls engage in trolling behavior, we ask: RQ: Can situational factors trigger trolling behavior? Causes of antisocial behavior Previous work has suggested several motivations for engag- ing in antisocial behavior: out of boredom [86], for fun [80], or to vent [55]. Still, this work has been largely qualita- tive and non-causal, and whether these motivations apply to the general population remains largely unknown. Out of this broad literature, we identify two possible trigger mechanisms of trolling – mood and discussion context – and try to es- tablish their effects using both a controlled experiment and a large-scale longitudinal analysis. Mood. Bad moods may play a role in how a person later acts. Negative mood correlates with reduced satisfaction with life [79], impairs self-regulation [56], and leads to less fa- vorable impressions of others [29]. Similarly, exposure to unrelated aversive events (e.g., higher temperatures [74] or secondhand smoke [41]) increases aggression towards others. An interview study found that people thought that malicious comments by others resulted from "anger and feelings of in- feriority" [55]. Nonetheless, negative moods elicit greater attention to detail and higher logical consistency [78], which suggests that peo- ple in a bad mood may provide more thoughtful commentary. 1In contrast to cyberbullying, defined as behavior that is repeated, intended to harm, and targeted at specific individuals [82], this def- inition of trolling encompasses a broader set of behaviors that may be one-off, unintentional, or untargeted. Prior work is also mixed on how affect influences prejudice and stereotyping. Both positive [10] and negative affect [34] can increase stereotyping, and thus trigger trolling [38]. Still, we expect the negative effects of negative mood in social con- texts to outweigh these other factors. Circumstances that influence mood may also modify the rate of trolling. For instance, mood changes with the time of day or day of week [32]. As negative mood rises at the start of the week, and late at night, trolling may vary similarly. "Time- outs" or allowing for a period of calming down [45] can also reduce aggression – users who wait longer to post after a bout of trolling may also be less susceptible to future trolling. Thus, we may be able to observe how mood affects trolling, directly through experimentation, and indirectly through ob- serving factors that influence mood: H1: Negative mood increases a user's likelihood of trolling. Discussion context. A discussion's context may also affect what people contribute. The discussion starter influences the direction of the rest of the discussion [36]. Qualitative anal- yses suggest that people think online commenters follow suit in posting positive (or negative) comments [55]. More gen- erally, standards of behavior (i.e., social norms) are inferred from the immediate environment [15, 20, 63]. Closer to our work is an experiment that demonstrated that less thoughtful posts led to less thoughtful responses [83]. We extend this work by studying amplified states of antisocial behavior (i.e., trolling) in both experimental and observational settings. On the other hand, users may not necessarily react to trolling with more trolling. An experiment that manipulated the initial votes an article received found that initial downvotes tended to be corrected by the community [64]. Some users respond to trolling with sympathy or understanding [4], or apologies or joking [54]. Still, such responses are rarer [4]. Another aspect of a discussion's context is the subject of dis- cussion. In the case of discussions on news sites, the topic of an article can affect the amount of abusive comments posted [30]. Overall, we expect that previous troll posts, regardless of who wrote them, are likely to result in more subsequent trolling, and that the topic of discussion also plays a role: H2: The discussion context (e.g., prior troll posts by other users) affects a user's likelihood of trolling. Influence and antisocial behavior That people can be influenced by environmental factors sug- gests that trolling could be contagious – a single user's out- burst might lead to multiple users participating in a flame war. Prior work on social influence [5] has demonstrated multi- ple examples of herding behavior, or that people are likely to take similar actions to previous others [21, 62, 95]. Similarly, emotions and behavior can be transferred from person to per- son [6, 13, 31, 50, 89]. More relevant is work showing that getting downvoted leads people to downvote others more and post content that gets further downvoted in the future [17]. These studies generally point toward a "Broken Windows" hypothesis, which postulates that untended behavior can lead to the breakdown of a community [92]. As an unfixed bro- ken window may create a perception of unruliness, comments made in poor taste may invite worse comments. If antisocial behavior becomes the norm, this can lead a community to further perpetuate it despite its undesirability [91]. Further evidence for the impact of antisocial behavior stems from research on negativity bias – that negative traits or events tend to dominate positive ones. Negative entities are more contagious than positive ones [75], and bad impressions are quicker to form and more resistant to disconfirmation [7]. Thus, we expect antisocial behavior is particularly likely to be influential, and likely to persist. Altogether, we hypothesize: H3: Trolling behavior can spread from user to user. We test H1 and H2 using a controlled experiment, then ver- ify and extend our results with an analysis of discussions on CNN.com. We test H3 by studying the evolution of discus- sions on CNN.com, finally developing an overall model for how trolling might spread from person to person. EXPERIMENT: MOOD AND DISCUSSION CONTEXT To establish the effects of mood and discussion context, we deployed an experiment designed to replicate a typical online discussion of a news article. Specifically, we measured the effect of mood and discussion context on the quality of the resulting discussion across two factors: a) POSMOOD or NEGMOOD: participants were ei- ther exposed to an unrelated positive or negative prior stim- ulus (which in turn affected their prevailing mood), and b) POSCONTEXT or NEGCONTEXT: the initial posts in the discussion thread were either benign (or not troll-like), or troll-like. Thus, this was a two-by-two between-subjects de- sign, with participants assigned in a round robin to each of the four conditions. We evaluated discussion quality using two measures: a) trolling behavior, or whether participants wrote more trol- l-like posts, and b) affect, or how positive or negative the re- sulting discussion was, as measured using sentiment analysis. If negative mood (NEGMOOD) or troll posts (NEGCONTEXT) affects the probability of trolling, we would expect these con- ditions to reduce discussion quality. Experimental Setup The experiment consisted of two main parts – a quiz, fol- lowed by a discussion – and was conducted on Amazon Me- chanical Turk (AMT). Past work has also recruited workers to participate in experiments with online discussions [60]. Par- ticipants were restricted to residing in the US, only allowed to complete the experiment once, and compensated $2.00, for an hourly rate of $8.00. To avoid demand characteristics, par- ticipants were not told of the experiment's purpose prior, and were only instructed to complete a quiz, and then participate in an online discussion. After the experiment, participants were debriefed and told of its purpose (i.e., to measure the impact of mood and trolling in discussions). The experimen- tal protocol was reviewed and conducted under IRB Protocol #32738. (a) (b) Figure 1: To understand how a person's mood and discussion's context (i.e., prior troll posts) affected the quality of a discussion, we conducted an experiment that varied (a) how difficult a quiz, given prior to participation in the discussion, was, as well as (b) whether the initial posts in a discussion were troll posts or not. Quiz (POSMOOD or NEGMOOD). The goal of the quiz was to see if participants' mood prior to participating in a dis- cussion had an effect on subsequent trolling. Research on mood commonly involves giving people negative feedback on tasks that they perform in laboratory experiments regard- less of their actual performance [48, 93, 33]. Adapting this to the context of AMT, where workers care about their per- formance on tasks and qualifications (which are necessary to perform many higher-paying tasks), participants were in- structed to complete an experimental test qualification that was being considered for future use on AMT. They were told that their performance on the quiz would have no bearing on their payment at the end of the experiment. The quiz consisted of 15 open-ended questions, and included logic, math, and word problems (e.g., word scrambles) (Fig- ure 1a). In both conditions, participants were given five min- utes to complete the quiz, after which all input fields were disabled and participants forced to move on. In both the POS- MOOD and NEGMOOD conditions, the composition and or- der of the types of questions remained the same. However, the NEGMOOD condition was made up of questions that were substantially harder to answer within the time limit: for exam- ple, unscramble "DEANYON" (NEGMOOD) vs. "PAPHY" (POSMOOD). At the end of the quiz, participants' answers were automatically scored, and their final score displayed to them. They were told whether they performed better, at, or worse than the "average", which was fixed at eight correct questions. Thus, participants were expected to perform well in the POSMOOD condition and receive positive feedback, and expected to perform poorly in the NEGMOOD condition and receive negative feedback, being told that they were per- forming poorly, both absolutely and relatively to other users. While users in the POSMOOD condition can still perform poorly, and users in the NEGMOOD condition perform well, this only reduces the differences later observed. To measure participants' mood following the quiz, and act- ing as a manipulation check, participants then completed 65 Likert-scale questions on how they were feeling based on the Proportion of Troll Posts POSMOOD NEGMOOD 35% 47% 49% 68% Negative Affect (LIWC) POSMOOD NEGMOOD 1.1% 2.3% 1.4% 2.9% POSCONTEXT NEGCONTEXT Table 1: The proportion of user-written posts that were la- beled as trolling (and proportion of words with negative af- fect) was lowest in the (POSMOOD, POSCONTEXT) condi- tion, and highest, and almost double, in the (NEGMOOD, NEGCONTEXT) condition (highlighted in bold). Profile of Mood States (POMS) questionnaire [61], which quantifies mood on six axes such as anger and fatigue. Discussion (POSCONTEXT or NEGCONTEXT). Partici- pants were then instructed to take part in an online discus- sion, and told that we were testing a comment ranking al- gorithm. Here, we showed participants an interface similar to what they might see on a news site - a short article, followed by a comments section. Users could leave comments, reply to others' comments, or upvote and downvote comments (Figure 1b). Participants were required to leave at least one comment, and told that their comments may be seen by other partici- pants. Each participant was randomly assigned a username (e.g., User1234) when they commented. In this experiment, we showed participants an abridged version of an article ar- guing that women should vote for Hillary Clinton instead of Bernie Sanders in the Democratic primaries leading up to the 2016 US presidential election [42]. In the NEGCONTEXT condition, the first three comments were troll posts, e.g.,: Oh yes. By all means, vote for a Wall Street sellout – a lying, abuse-enabling, soon-to-be felon as our next Pres- ident. And do it for your daughter. You're quite the role model. In the POSCONTEXT, they were more innocuous: I'm a woman, and I don't think you should vote for a woman just because she is a woman. Vote for her be- cause you believe she deserves it. Fixed Effects (Intercept) NEGMOOD NEGCONTEXT NEGMOOD × NEGCONTEXT Random Effects User Coef. −0.70∗∗∗ 0.64∗∗ 0.52∗ 0.41 Var. 0.41 SE 0.17 0.24 0.23 0.33 SE 0.64 z −4.23 2.66 2.38 1.23 Table 2: A mixed effects logistic regression reveals a signif- icant effect of both NEGMOOD and NEGCONTEXT on troll posts (∗: p<0.05, ∗∗: p<0.01, ∗∗∗: p<0.001). In other words, both negative mood and the presence of initial troll posts in- creases the probability of trolling. These comments were abridged from real comments posted by users in comments in the original article, as well as other online discussion forums discussing the issue (e.g., Reddit). To ensure that the effects we observed were not path- dependent (i.e., if a discussion breaks down by chance be- cause of a single user), we created eight separate "universes" for each condition [76], for a total of 32 universes. Each uni- verse was seeded with the same comments, but were other- wise entirely independent. Participants were randomized be- tween universes within each condition. Participants assigned to the same universe could see and respond to other partici- pants who had commented prior, but not interact with partic- ipants from other universes. Measuring discussion quality. We evaluated discussion quality in two ways: if subsequent posts written exhibited trolling behavior, or if they contained more negative affect. To evaluate whether a post was a troll post or not, two experts (including one of the authors) independently labeled posts as being troll or non-troll posts, blind to the experimental condi- tions, with disagreements resolved through discussion. Both experts reviewed CNN.com's community guidelines [22] for commenting – posts that were offensive, irrelevant, or de- signed to elicit an angry response, whether intentional or not, were labeled as trolling. To measure the negative affect of a post, we used LIWC [68] (Vader [40] gives similar results). Results 667 participants (40% female, mean age 34.2, 54% Demo- crat, 25% Moderate, 21% Republican) completed the experi- ment, with an average of 21 participants in each universe. In aggregate, these workers contributed 791 posts (with an aver- age of 37.8 words written per post) and 1392 votes. Manipulation checks. First we sought to verify that the quiz did affect participants' mood. On average, participants in the POSMOOD condition obtained 11.2 out of 15 ques- tions correct, performing above the stated "average" score of 8. In contrast, participants in the NEGMOOD condition an- swered only an average of 1.9 questions correctly, perform- ing significantly worse (t(594)=63.2, p<0.001 using an un- equal variances t-test), and below the stated "average". Corre- spondingly, the post-quiz POMS questionnaire confirmed that participants in the NEGMOOD condition experienced higher mood disturbance on all axes, with higher anger, confusion, depression, fatigue, and tension scores, and a lower vigor score (t(534)>7.0, p<0.001). Total mood disturbance, where higher scores correspond to more negative mood, was 12.2 for participants in the POSMOOD condition (comparable to a baseline level of disturbance measured among athletes [85]), and 40.8 in the NEGMOOD condition. Thus, the quiz put par- ticipants into a more negative mood. Verifying that the initial posts in the NEGCONTEXT condi- tion were perceived as being more troll-like than those in the POSCONTEXT condition, we found that the initial posts in the NEGCONTEXT condition were less likely to be upvoted (36% vs. 90% upvoted for POSCONTEXT, t(507)=15.7, p<0.001). Negative mood and negative context increase trolling be- havior. Table 1 shows how the proportion of troll posts and negative affect (measured as the proportion of nega- tive words) differ in each condition. The proportion of troll posts was highest in the (NEGMOOD, NEGCONTEXT) con- dition with 68% troll posts, drops in both the (NEGMOOD, POSCONTEXT) and (POSMOOD, NEGCONTEXT) conditions with 47% and 49% each, and is lowest in the (POSMOOD, POSCONTEXT) condition with 35%. For negative affect, we observe similar differences. Fitting a mixed effects logistic regression model, with the two conditions as fixed effects, an interaction between the two conditions, user as a random effect, and whether a con- tributed post was trolling or not as the outcome variable, we do observe a significant effect of both NEGMOOD and NEG- CONTEXT (p<0.05) (Table 2). These results confirm both H1 and H2, that negative mood and the discussion context (i.e., prior troll posts) increase a user's likelihood of trolling. Neg- ative mood increases the odds of trolling by 89%, and the presence of prior troll posts increases the odds by 68%. A mixed model using MCMC revealed similar effects (p<0.05), and controlling for universe, gender, age, or political affilia- tion also gave similar results. Further, the effect of a post's position in the discussion on trolling was not significant, sug- gesting that trolling tends to persist in the discussion. With the proportion of words with negative affect as the out- come variable, we observed a significant effect of NEGCON- TEXT (p<0.05), but not of NEGMOOD – such measures may not accurately capture types of trolling such as sarcasm or off- topic posting. There was no significant effect of either factor on positive affect. Examples of troll posts. Contributed troll posts comprised a relatively wide range of antisocial behavior: from out- right swearing ("What a dumb c***") and personal attacks ("You're and idiot and one of the things that's wrong with this country.") to veiled insults ("Hillary isn't half the man Bernie is!!! lol"), sarcasm ("You sound very white, and very male. Must be nice."), and off-topic statements ("I think Ted Cruz has a very good chance of becoming president."). In con- trast, non-troll posts tended to be more measured, regardless of whether they agreed with the article ("Honestly I agree too. I think too many people vote for someone who they identify with rather than someone who would be most qualified."). Other results. We observed trends in the data. Both con- ditions reduced the number of words written relative to the control condition: 44 words written in the (POSMOOD, POSCONTEXT) vs. 29 words written in the (NEGMOOD, NEGCONTEXT) condition. Also, the percentage of upvotes on posts written by other users (i.e., excluding the initial seed posts) was lower: 79% in the (POSMOOD, POSCONTEXT) condition vs. 75% in the (NEGMOOD, NEGCONTEXT) con- dition. While suggestive, neither effect was significant. Discussion. Why did NEGCONTEXT and NEGMOOD in- crease the rate of trolling? Drawing on prior research explain- ing the mechanism of contagion [89], participants may have an initial negative reaction to reading the article, but are un- likely to bluntly externalize them because of self-control or environmental cues. NEGCONTEXT provides evidence that others had similar reactions, making it more acceptable to also express them. NEGMOOD further accentuates any per- ceived negativity from reading the article and reduces self- inhibition [56], making participants more likely to act out. Limitations. In this experiment, like prior work [60, 83], we recruited participants to participate in an online discussion, and required each to post at least one comment. While this enables us isolate both mood and discussion context (which is difficult to control for in a live Reddit discussion for exam- ple) and further allows us to debrief participants afterwards, payment may alter the incentives to participate in the discus- sion. Users also were commenting pseudonymously via ran- domly generated usernames, which may reduce overall com- ment quality [46]. Different initial posts may also elicit dif- ferent subsequent posts. While our analyses did not reveal significant effects of demographic factors, future work could further examine their impact on trolling. For example, men may be more susceptible to trolling as they tend to be more aggressive [8]. Anecdotally, several users who identified as Republican trolled the discussion with irrelevant mentions of Donald Trump (e.g., "I'm a White man and I'm definitely vot- ing for Donald Trump!!!"). Understanding the effects of dif- ferent types of trolling (e.g., swearing vs. sarcasm) and user motivations for such trolling (e.g., just to rile others up) also remains future work. Last, different articles may be trolled to different extents [30], so we examine the effect of article topic in our subsequent analyses. Overall, we find that both mood and discussion context sig- nificantly affect a user's likelihood of engaging in trolling be- havior. For such effects to be observable, a substantial propor- tion of the population must have been susceptible to trolling, rather than only a small fraction of atypical users – suggest- ing that trolling can be generally induced. But do these re- sults generalize to real-world online discussions? In the sub- sequent sections, we verify and extend our results with an analysis of CNN.com, a large online news discussion com- munity. After describing this dataset, we study how trolling behavior tracks known daily mood patterns, and how mood persists across multiple discussions. We again find that the initial posts of discussions have a significant effect on subse- quent posts, and study the impact of the volume and ordering of multiple troll posts on subsequent trolling. Extending our analysis of discussion context to include the accompanying article's topic, we find that it too mediates trolling behavior. DATA: INTRODUCTION CNN.com is a popular American news website where edi- tors and journalists write articles on a variety of topics (e.g., politics and technology), which users can then discuss. In addition to writing and replying to posts, users can up- and down-vote, as well as flag posts (typically for abuse or viola- tions of the community guidelines [22]). Moderators can also delete posts or even ban users, in keeping with these guide- lines. Disqus, a commenting platform that hosted these dis- cussions on CNN.com, provided us with a complete trace of user activity from December 2012 to August 2013, consisting of 865,248 users (20,197 banned), 16,470 discussions, and 16,500,603 posts, of which 571,662 (3.5%) were flagged and 3,801,774 (23%) were deleted. Out of all flagged posts, 26% were made by users with no prior record of flagging in pre- vious discussions; also, out of all users with flagged posts who authored at least ten posts, 40% had less than 3.5% of their posts flagged (the baseline probability of a random post being flagged on CNN). These observations suggest that ordi- nary users are responsible for a significant amount of trolling behavior, and that many may have just been having a bad day. In studying behavior on CNN.com, we consider two main units of analysis: a) a discussion, or all the posts that follow a given news article, and b) a sub-discussion, or a top-level post and any replies to that post. We make this distinction as dis- cussions may reach thousands of posts, making it likely that users may post in a discussion without reading any previous responses. In contrast, a sub-discussion necessarily involves replying to a previous post, and would allow us to better study the effects of people reading and responding to each other. In our subsequent analyses, we filter banned users (of which many tend to be clearly identifiable trolls [18]), as well as any users who had all of their posts deleted, as we are primar- ily interested in studying the effects of mood and discussion context on the general population. We use flagged posts (posts that CNN.com users marked for violating community guidelines) as our primary measure of trolling behavior. In contrast, moderator deletions are typi- cally incomplete: moderators miss some legitimate troll be- havior and tend to delete entire discussions as opposed to in- dividual posts. Likewise, written negative affect misses sar- casm and other trolling behaviors that do not involve common negative words, and downvoting may simply indicate dis- agreement. To validate this approach, two experts (including one of the authors) labeled 500 posts (250 flagged) sampled at random, blind to whether each post was flagged, using the same criteria for trolling as for the experiment. Comparing the expert labels with post flags from the dataset, we obtained a precision of 0.66 and recall of 0.94, suggesting that while some troll posts remain unflagged, almost all flagged posts are troll posts. In other words, while instances of trolling be- havior go unnoticed (or are ignored), when a post is flagged, it is highly likely that trolling behavior did occur. So, we use flagged posts as a primary estimate of trolling behavior in our analyses, complementing our analysis with other signals Still, trolls may simply wake up later than normal users, or post on different days. To understand how the time of day and day of week affect the same user, we compare these mea- sures for the same user in two different time periods: from 6 am to 12 pm and from 11 pm to 5 am, and on two differ- ent days: Monday and Friday (i.e., early or late in the work week). A paired t-test reveals a small, but significant increase in negative behavior between 11 pm and 5 am (flagged posts: 4.1% vs. 4.3%, d=0.01, t(106300)=2.79, p<0.01; negative af- fect: 3.3% vs. 3.4%, t(106220)=3.44, d=0.01, p<0.01; down- votes: 20.6% vs. 21.4%, d=0.02, t(26390)=2.46, p<0.05). Posts made on Monday also show more negative behavior than posts made on Friday (d≥0.02, t>2.5, p<0.05). While these effects may also be influenced by the type of news that gets posted at specific times or days, limiting our analysis to just news articles categorized as "US" or "World", the two largest sections, we continue to observe similar results. Thus, even without direct user mood measurements, patterns of trolling behavior correspond predictably with mood. Anger begets more anger Negative mood can persist beyond the events that brought about those feelings [44]. If trolling is dependent on mood, we may be able to observe the aftermath of user outbursts, where negative mood might spill over from prior discus- sions into subsequent, unrelated ones, just as our experiment showed that negative mood that resulted from doing poorly on a quiz affected later commenting in a discussion. Further, we may also differentiate the effects that stem from actively engaging in negative behavior in the past, versus simply being exposed to negative behavior. Correspondingly, we ask two questions, and answer them in turn. First, a) if a user wrote a troll post in a prior discussion, how does that affect their probability of trolling in a subsequent, unrelated discussion? At the same time, we might also observe indirect effects of trolling: b) if a user participated in a discussion where trolling occurred, but did not engage in trolling behavior themselves, how does that affect their probability of trolling in a subse- quent, unrelated discussion? To answer the former, for a given discussion, we sample two users at random, where one had a post which was flagged, and where one had a post which was not flagged. We ensure that these two users made at least one post prior to participating in the discussion, and match users on the total number of posts they wrote prior to the discussion. As we are interested in these effects on ordinary users, we also ensure that neither of these users have had any of their posts flagged in the past. We then compare the likelihood of each user's next post in a new discussion also being flagged. We find that users who had a post flagged in a prior discussion were twice as likely to troll in their next post in a different discussion (4.6% vs. 2.1%, d=0.14, t(4641)=6.8, p<0.001) (Figure 3a). We obtain similar results even when requiring these users to also have no prior deleted posts or longer histories (e.g., if they have written at least five posts prior to the discussion). Next, we examine the indirect effect of participating in a "bad" discussion, even when the user does not directly en- gage in trolling behavior. We again sample two users from the Figure 3: Suggesting that negative mood may persist across discussions, users with no prior history of flagged posts, who either (a) make a post in a prior unrelated discussion that is flagged, or (b) simply participates in a sub-discussion in a prior discussion with at least one flagged post, without themselves being flagged, are more likely to be subsequently flagged in the next discussion they participate in. Demonstrat- ing the effect of discussion context, (c) discussions that begin with a flagged post are more likely to have a greater propor- tion of flagged posts by other users later on, as do (d) sub- discussions that begin with a flagged post. such as negative affect and downvotes. These signals are cor- related: flagged posts are more likely than non-flagged posts to have greater negative affect (3.7% vs. 3.4% of words, Co- hen's d=0.06, t=40, p<0.001), be downvoted (58% vs. 30% of votes, d=0.76, t=531, p<0.001), or be deleted by a moder- ator (79% vs. 21% of posts, d=1.4, t=1050, p<0.001). DATA: UNDERSTANDING MOOD In the earlier experiment, we showed that bad mood increases the probability of trolling. In this section, using large-scale and longitudinal observational data, we verify and expand on this result. While we cannot measure mood directly, we can study its known correlates. Seasonality influences mood [32], so we study how trolling behavior also changes with the time of day or day of week. Aggression can linger beyond an ini- tial unpleasant event [41], thus we also study how trolling be- havior persists as a user participates in multiple discussions. Happy in the day, sad at night Prior work that studied changes in linguistic affect on Twitter demonstrated that mood changes with the time of the day, and with the day of the week – positive affect peaks in the morning, and during weekends [32]. If mood changes with time, could trolling be similarly affected? Are people more likely to troll later in the day, and on weekdays? To evaluate the impact of the time of day or day of week on mood and trolling behavior, we track several measures that may indicate troll-like behavior: a) the proportion of flagged posts (or posts reported by other users as being abusive), b) negative affect, and c) the proportion of downvotes on posts (or the average fraction of downvotes on posts that received at least one vote). Figures 2a and 2b show how each of these measures changes with the time of day and day of week, respectively, across all posts. Our findings corroborate prior work – the proportion of flagged posts, negative affect, and the proportion of down- votes are all lowest in the morning, and highest in the evening, aligning with when mood is worst [32]. These measures also peak on Monday (the start of the work week in the US). 0.0000.0250.0500.0750.100(a)(b)(c)(d)Pr(Later Post(s) Flagged)UnflaggedFlagged (a) Time of Day (EDT) (b) Day of Week (c) Time Since Last Post Figure 2: Like negative mood, indicators of trolling peak (a) late at night, and (b) early in the work week, supporting a relation between mood and trolling. Further, (c) the shorter the time between a user's subsequent posts in unrelated discussions, where the first post is flagged, the more likely the second will also be flagged, suggesting that negative mood may persist for some time. same discussion, but where each user participated in a differ- ent sub-discussion: one sub-discussion had at least one other post by another user flagged, and the other sub-discussion had no flagged posts. Again, we match users on the number of posts they wrote in the past, and ensure that these users have no prior flagged posts (including in the sampled discussions). We then compare the likelihood of each user's next post in a new discussion being flagged. Here, we also find that users who participated in a prior discussion with at least one flagged post were significantly more likely to subsequently author a post in an new discussion that would be flagged (Figure 3b). However, this effect is significantly weaker (2.2% vs. 1.7%, d=0.04, t(7321)=2.7, p<0.01). Thus, both trolling in a past discussion, as well as participat- ing in a discussion where trolling occurred, can affect whether a user trolls in the future discussion. These results suggest that negative mood can persist and transmit trolling norms and behavior across multiple discussions, where there is no similar context to draw on. As none of the users we analyzed had prior flagged posts, this effect is unlikely to arise simply because some users were just trolls in general. Time heals all wounds One typical anger management strategy is to use a "time-out" to calm down [45]. Thus, could we minimize negative mood carrying over to new discussions by having users wait longer before making new posts? Assuming that a user is in a nega- tive mood (as indicated by writing a post that is flagged), the time elapsed until the user's next post may correlate with the likelihood of subsequent trolling. In other words, we might expect that the longer time the time between posts, the greater the temporal distance from the origin of the negative mood, and hence the lower the likelihood of trolling. Figure 2c shows how the probability of a user's next post be- ing flagged changes with the time since that user's last post, assuming that the previous post was flagged. So as not to con- fuse the effects of the initial post's discussion context, we en- sure that the user's next post is made in a new discussion with different other users. The probability of being flagged is high when the time between these two subsequent posts is short (five minutes or less), suggesting that a user might still be in a negative mood persisting from the initial post. As more time passes, even just ten minutes, the probability of being flagged gradually decreases. Nonetheless, users with better impulse control may wait longer before posting again if they are angry, and isolating this effect would be future work. Our findings here lend credence to the rate-limiting of posts that some forums have introduced [2]. DATA: UNDERSTANDING DISCUSSION CONTEXT From our experiment, we identified mood and discussion con- text as influencing trolling. The previous section verified and extended our results on mood; in this section, we do the same for discussion context. In particular, we show that posts are more likely to be flagged if others' prior posts were also flagged. Further, the number and ordering of flagged posts in a discussion affects the probability of subsequent trolling, as does the topic of the discussion. "FirST!!1" How strongly do the initial posts to a discussion affect the likelihood of subsequent posts to troll? To measure the effect of the initial posts on subsequent discussions, we first iden- tified discussions of at least 20 posts, separating them into those with their first post flagged and those without their first post flagged. We then used propensity score matching to cre- ate matched pairs of discussions where the topic of the article, the day of week the article was posted, and the total number of posts are controlled for [72]. Thus, we end up with pairs of discussions on the same topic, started on the same day of the week, and with similar popularity, but where one discus- sion had its first post flagged, while the other did not. We then compare the probability of the subsequent posts in the discussion being flagged. As we were interested in the im- pact of the initial post on other ordinary users, we excluded any posts written by the user who made the initial post, posts by users who replied (directly or indirectly) to that post, and posts by users with prior flagged or deleted posts in previous discussions. After an initial flagged post, we find that subsequent posts by other users were more likely to be flagged, than if the initial post was not flagged (3.1% vs. 1.7%, d=0.32, t(1545)=9.1, p<0.001) (Figure 3c). This difference remains significant even when only considering posts made in the second half of a discussion (2.1% vs. 1.3%, d=0.19, t(1545)=5.4, p<0.001). ●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●0.0300.0330.0360.0390.03300.03350.03400.03450.03500.290.300.310.320.330.34Prop.Flagged PostsNegativeAffectProp.Downvotes05101520Mean●●●●●●●●●●●●●●●●●●●●●0.03250.03500.03750.04000.03350.03400.03450.300.310.320.33Prop.Flagged PostsNegativeAffectProp.DownvotesMonTueWedThuFriSatSunMean0.000.030.060.095 min10 min1 hr3 hrs1 day1 weekPr(Next Post is Flagged) (a) # of Prior Flagged Posts (b) Position of Flagged Post (c) Flagged Posts by Topic Figure 4: In discussions with at least five posts, (a) the probability that a post is flagged monotonically increases with the number of prior flagged posts in the discussion. (b) If only one of the first four posts was flagged, the fifth post is more likely to be flagged if that flagged post is closer in position. (c) The topic of a discussion also influences the probability of a post being flagged. Comparing discussions where the first three posts were all flagged to those where none of these posts were flagged (similar to NEGCONTEXT vs. POSCONTEXT in our exper- iment), the gap widens (7.1% vs. 1.7%, d=0.61, t(113)=4.6, p<0.001). Nonetheless, as these different discussions were on differ- ent articles, some articles, even within the same topic, may have been more inflammatory, increasing the overall rate of flagging. To control for the article being discussed, we also look at sub-discussions (a top-level post and all of its replies) within the same discussion. Sub-discussions tend to be closer to actual conversations between users as each subsequent post is an explicit reply to another post in the chain, as op- posed to considering the discussion as a whole where users can simply leave a comment without reading or responding to anyone else. From each discussion we select two sub- discussions at random, where one sub-discussion's top-level post was flagged, and where the other's was not, and only considered posts not written by the users who started these sub-discussions. Again, we find that sub-discussions whose top-level posts were flagged were significantly more likely to result in more flagging later in that sub-discussion (9.6% vs. 5.9%, d=0.16, t(501)=3.9, p<0.001) (Figure 3d). Altogether, these results suggest that the initial posts in a dis- cussion set a strong, lasting precedent for later trolling. From bad to worse: sequences of trolling By analyzing the volume and ordering of troll posts in a dis- cussion, we can better understand how discussion context and trolling behavior interact. Here, we study sub-discussions at least five posts in length, and separately consider posts written by users new to the sub-discussion and posts written by users who have posted before in the sub-discussion to control for the impact of having already participated in the discussion. Do more troll posts increase the likelihood of future troll posts? Figure 4a shows that as the number of flagged posts among the first four posts increases, the probability that the fifth post is also flagged increases monotonically. With no prior flagged posts, the chance of the fifth post by a new user to the sub-discussion being flagged is just 2%; with one other flagged post, this jumps to 7%; with four flagged posts, the odds of the fifth post also being flagged are almost one to one (49%). These pairwise differences are all significant with a Holm correction (χ2(1)>7.6, p<0.01). We observe simi- lar trends for users new to the sub-discussion, as well as users that had posted previously, with the latter group of users more likely to be subsequently flagged. Further, does a troll post made later in a discussion, and closer to where a user's post will show up, have a greater impact than a troll post made earlier on? Here, we look at discus- sions of at least five posts where there was exactly one flagged post among the first four, and where that flagged post was not written by the fifth post's author. In Figure 4b, the closer in position the flagged post is to the fifth post, the more likely that post is to be flagged. For both groups of users, the fifth post in a discussion is more likely to be flagged if the fourth post was flagged, as opposed to the first (χ2(1)>6.9, p<0.01). Beyond the presence of troll posts, their conspicuousness in discussions substantially affects if new discussants troll as well. These findings, together with our previous results show- ing how simply participating in a previous discussion having a flagged post raises the likelihood of future trolling behavior, support H3: that trolling behavior spreads from user to user. Hot-button issues push users' buttons? How does the subject of a discussion affect the rate of trolling? Controversial topics (e.g., gender, GMOs, race, re- ligion, or war) may divide a community [57], and thus lead to more trolling. Figure 4c shows the average rate of flagged posts of articles belonging to different sections of CNN.com. Post flagging is more frequent in the health, justice, showbiz, sport, US, and world sections (near 4%), and less frequent in the opinion, politics, tech, and travel sections (near 2%). Flagging may be more common in the health, justice, US, and world sections because these sections tend to cover con- troversial issues: a linear regression unigram model using the titles of articles to predict the proportion of flagged posts re- vealed that "Nidal" and "Hasan" (the perpetrator of the 2009 Fort Hood shooting) were among the most predictive words in the justice section. For the showbiz and sport sections, inter-group conflict may have a strong effect (e.g., fans of op- posing teams) [81]. Though political issues in the US may appear polarizing, the politics section has one of the lowest rates of post flagging, similar to tech. Still, a deeper analysis ●●●●●0.00.20.40.601234Pr(5th Post is Flagged)●New ParticipantPosted Before●●●●0.060.080.101234Pr(5th Post is Flagged)●New ParticipantPosted Before0.000.010.020.030.04HealthJusticeOpinionPoliticsShowbizSportTechTravelUSWorldPr(Post is Flagged) Feature Set Seasonality (31) Recent User History (4) Previous Posts (15) Article Topic (13) Overall User History (2) User ID (45895) Mood Discussion Context User-specific Combined Previous Posts + Recent User History (19) All Features AUC 0.53 0.60 0.74 0.58 0.66 0.66 0.77 0.78 Table 3: In predicting trolling in a discussion, features relat- ing to the discussion's context are most informative, followed by user-specific and mood features. This suggests that while some users are inherently more likely to troll, the context of a discussion plays a greater role in whether trolling actually occurs. The number of binary features is in parentheses. of the interplay of these factors (e.g., personal values, group membership, and topic) with trolling remains future work. The relatively large variation here suggests that the topic of a discussion influences the baseline rate of trolling, where hot- button topics spark more troll posts. Summary Through experimentation and data analysis, we find that sit- uational factors such as mood and discussion context can in- duce trolling behavior, answering our main research question (RQ). Bad mood induces trolling, and trolling, like mood, varies with time of day and day of week; bad mood may also persist across discussions, but its effect diminishes with time. Prior troll posts in a discussion increase the likelihood of fu- ture troll posts (with an additive effect the more troll posts there are), as do more controversial topics of discussion. A MODEL OF HOW TROLLING SPREADS Thus far, our investigation sought to understand whether ordi- nary users engage in trolling behavior. In contrast, prior work suggested that trolling is largely driven by a small population of trolls (i.e., by intrinsic characteristics such as personality), and our evidence suggests complementary hypotheses – that mood and discussion context also affect trolling behavior. In this section, we construct a combined predictive model to un- derstand the relative strengths of each explanation. We model each explanation through features in the CNN.com dataset. First, the impact of mood on trolling behavior can be modeled indirectly using seasonality, as expressed through time of day and day of week; and a user's recent posting his- tory (outside of the current discussion), in terms of the time elapsed since the last post and whether the user's previous post was flagged. Second, the effect of discussion context can be modeled using the previous posts that precede a user's in a discussion (whether any of the previous five posts in the discussion were flagged, and if they were written by the same user); and the topic of discussion (e.g., politics). Third, to evaluate if trolling may be innate, we use a user's User ID to learn each user's base propensity to troll, and the user's over- all history of prior trolling (the total number and proportion of flagged posts accumulated). Our prediction task is to guess whether a user will write a post that will get flagged, given features relating to the dis- cussion or user. We sampled posts from discussions at ran- dom (N=116,026), and balance the set of users whose posts are later flagged and users whose posts are not flagged, so that random guessing results in 50% accuracy. To under- stand trolling behavior across all users, this analysis was not restricted to users who did not have their posts previously flagged. We use a logistic regression classifier, one-hot en- coding features (e.g., time of day) as appropriate. A random forest classifier gives empirically similar results. Our results suggest that trolling is better explained as situa- tional (i.e., a result of the user's environment) than as innate (i.e., an inherent trait). Table 3 describes performance on this prediction task for different sets of features. Features relating to discussion context perform best (AUC=0.74), hinting that context alone is sufficient in predicting trolling behavior; the individually most predictive feature was whether the previ- ous post in the discussion was flagged. Discussion topic was somewhat informative (0.58), with the most predictive fea- ture being if the post was in the opinion section. In the exper- iment, mood produced a stronger effect than discussion con- text. However, here we cannot measure mood directly, so its feature sets (seasonality and recent user history) were weaker (0.60 and 0.53 respectively). Most predictive was if the user's last post in a different discussion was flagged, and if the post was written on Friday. Modeling each user's probability of trolling individually, or by measuring all flagged posts over their lifetime was moderately predictive (0.66 in either case). Further, user features do not improve performance beyond the using just the discussion context and a user's recent history. Combining previous posts with recent history (0.77) resulted in performance nearly as good as including all features (0.78). We continue to observe strong performance when restricting our analysis only to posts by users new to a discussion (0.75), or to users with no prior record of reported or deleted posts (0.70). In the latter case, it is difficult to detect trolling be- havior without discussion context features (<0.56). Overall, we find that the context in which a post is made is a strong predictor of a user later trolling, beyond their intrin- sic propensity to troll. A user's recent posting history is also predictive, suggesting that mood carries over from previous discussions, and that past trolling predicts future trolling. DISCUSSION While prior work suggests that some users may be born trolls and innately more likely to troll others, our results show that ordinary users will also troll when mood and discussion con- text prompt such behavior. The spread of negativity If trolling behavior can be induced, and can carry over from previous discussions, could such behavior cascade and lead to the community worsening overall over time? Figure 5 user feedback, typically by allowing users to up- and down- vote content, which reduces the likelihood of subsequent users encountering downvoted content. But though this ap- proach is scalable, downvoting can cause users to post worse comments, perpetuating a negative feedback loop [17]. Se- lectively exposing feedback, where positive signals are public and negative signals are hidden, may enable context to be al- tered without adversely affecting user behavior. Community norms can also influence a discussion's context: reminders of ethical standards or past moral actions (e.g., if users had to sign a "no trolling" pledge before joining a community) can also increase future moral behavior [59, 65]. Limitations and future work Though our results do suggest the overall effect of mood on trolling behavior, a more nuanced understanding of this rela- tion should require improved signals of mood (e.g., by using behavioral traces as described earlier). Models of discussions that account for the reply structure [3], changes in sentiment [87], and the flow of ideas [66, 94] may provide deeper in- sight into the effect of context on trolling behavior. Different trolling strategies may also vary in prevalence and severity (e.g., undirected swearing vs. targeted harassment and bullying). Understanding the effects of specific types of trolling may also allow us to design measures better targeted to the specific behaviors that may be more pertinent to deal with. The presence of social cues may also mediate the effect of these factors: while many online communities allow their users to use pseudonyms, reducing anonymity (e.g., through the addition of voice communication [23] or real name poli- cies [19]) can reduce bad behavior such as swearing, but may also reduce the overall likelihood of participation [19]. Fi- nally, differentiating the impact of a troll post and the intent of its author (e.g., did its writer intend to hurt others, or were they just expressing a different viewpoint? [55]) may help separate undesirable individuals from those who just need help communicating their ideas appropriately. Future work could also distinguish different types of users who end up trolling. Prior work that studied users banned from communities found two distinct groups – users whose posts were consistently deleted by moderators, and those whose posts only started to get deleted just before they were banned [18]. Our findings suggest that the former type of trolling may have been innate (i.e., the user was constantly trolling), while the latter type of trolling may have been situ- ational (i.e., the user was involved in a heated discussion). CONCLUSION Trolling stems from both innate and situational factors – where prior work has discussed the former, this work focuses on the latter, and reveals that both mood and discussion con- text affect trolling behavior. This suggests the importance of different design affordances to manage either type of trolling. Rather than banning all users who troll and violate commu- nity norms, also considering measures that mitigate the situa- tional factors that lead to trolling may better reflect the reality of how trolling occurs. Figure 5: On CNN.com, the proportion of flagged posts, as well as users with flagged posts, is increasing over time, sug- gesting that trolling behavior can spread and be reinforced. shows that on CNN.com, the proportion of flagged posts and proportion of users with flagged posts are rising over time. These upward trends suggest that trolling behavior is becom- ing more common, and that a growing fraction of users are engaging in such behavior. Comparing posts made in the first half and second half of the CNN.com dataset, the proportion of flagged posts and proportion of users with flagged posts increased (0.03 vs. 0.04 and 0.09 vs. 0.12, p<0.001). There may be several explanations for this (e.g., that users joining later are more susceptible to trolling), but our findings, to- gether with prior work showing that negative norms can be reinforced [91] and that downvoted users go on to downvote others [17], suggest that negative behavior can persist in and permeate a community when left unchecked. Designing better discussion platforms The continuing endurance of the idea that trolling is innate may be explained using the fundamental attribution error [73]: people tend to attribute a person's behavior to their internal characteristics rather than external factors – for ex- ample, interpreting snarky remarks as resulting from general mean-spiritedness (i.e., their disposition), rather than a bad day (i.e., the situation that may have led to such behavior). This line of reasoning may lead communities to incorrectly conclude that trolling is caused by people who are unques- tionably trolls, and that trolling can be eradicated by ban- ning these users. However, not only are some banned users likely to be ordinary users just having a bad day, but such an approach also does little to curb such situational trolling, which many ordinary users may be susceptible to. How might we design discussion platforms that minimize the spread of trolling behavior? Inferring mood through recent posting behavior (e.g., if a user just participated in a heated debate) or other behavioral traces such as keystroke movements [49], and selectively enforcing measures such as post rate-limiting [2] may discourage users from posting in the heat of the moment. Allowing users to retract recently posted comments may help minimize regret [88]. Alternatively, reducing other sources of user frustration (e.g., poor interface design or slow loading times [12]) may further temper aggression. Altering the context of a discussion (e.g., by hiding troll com- ments and prioritizing constructive ones) may increase the perception of civility, making users less likely to follow suit in trolling. To this end, one solution is to rank comments using 0.020.040.060.050.10Prop.Flagged PostsProp.Flagged UsersDecJanFebMarAprMayJunJulAugMean ACKNOWLEDGMENTS We would like to thank Chloe Kliman-Silver, Disqus for the data used in our observational study, and our reviewers for their helpful comments. This work was supported in part by a Microsoft Research PhD Fellowship, a Google Research Fac- ulty Award, NSF Grant IIS-1149837, ARO MURI, DARPA NGS2, SDSI, Boeing, Lightspeed, SAP, and Volkswagen. REFERENCES 1. Yavuz Akbulut, Yusuf Levent Sahin, and Bahadir Eristi. 2010. Cyberbullying Victimization among Turkish Online Social Utility Members. Educ. Technol. Soc. (2010). 2. Jeff Atwood. 2013. Why is there a topic reply limit for new users? http://bit.ly/1XDLk8a. (2013). 3. Lars Backstrom, Jon Kleinberg, Lillian Lee, and Cristian Danescu-Niculescu-Mizil. 2013. Characterizing and curating conversation threads: expansion, focus, volume, re-entry. In Proc. WSDM. 4. Paul Baker. 2001. Moral panic and alternative identity construction in Usenet. J. Comput. Mediat. Commun. (2001). 5. Abhijit V Banerjee. 1992. A simple model of herd behavior. Q. J. Econ. (1992). 6. Sigal G Barsade. 2002. The ripple effect: Emotional contagion and its influence on group behavior. Adm. Sci. Q. (2002). 7. Roy F Baumeister, Ellen Bratslavsky, Catrin Finkenauer, and Kathleen D Vohs. 2001. Bad is stronger than good. Rev. Gen. Psychol. (2001). 8. Leonard Berkowitz. 1993. Aggression: Its causes, consequences, and control. 9. Amy Binns. 2012. DON'T FEED THE TROLLS! Managing troublemakers in magazines' online communities. Journalism Practice (2012). 10. Galen V Bodenhausen, Geoffrey P Kramer, and Karin Susser. 1994. Happiness and stereotypic thinking in social judgment. J. Pers. Soc. Psychol. (1994). 11. Erin E Buckels, Paul D Trapnell, and Delroy L Paulhus. 2014. Trolls just want to have fun. Pers. Individ. Dif. (2014). 12. Irina Ceaparu, Jonathan Lazar, Katie Bessiere, John Robinson, and Ben Shneiderman. 2004. Determining causes and severity of end-user frustration. Int. J. Hum. Comput. Interact. (2004). 13. Damon Centola. 2010. The spread of behavior in an online social network experiment. Science (2010). 14. Stevie Chancellor, Zhiyuan Jerry Lin, and Munmun De Choudhury. 2016. This Post Will Just Get Taken Down: Characterizing Removed Pro-Eating Disorder Social Media Content. In Proc. SIGCHI. 15. Daphne Chang, Erin L Krupka, Eytan Adar, and Alessandro Acquisti. 2016. Engineering Information Disclosure: Norm Shaping Designs. In Proc. SIGCHI. 16. Zhansheng Chen, Kipling D Williams, Julie Fitness, and Nicola C Newton. 2008. When Hurt Will Not Heal: Exploring the Capacity to Relive Social and Physical Pain. Psychol. Sci. (2008). 17. Justin Cheng, Cristian Danescu-Niculescu-Mizil, and Jure Leskovec. 2014. How community feedback shapes user behavior. In Proc. ICWSM. 18. Justin Cheng, Cristian Danescu-Niculescu-Mizil, and Jure Leskovec. 2015. Antisocial Behavior in Online Discussion Communities. In Proc. ICWSM. 19. Daegon Cho and Alessandro Acquisti. 2013. The more social cues, the less trolling? An empirical study of online commenting behavior. In Proc. WEIS. 20. Robert B Cialdini and Noah J Goldstein. 2004. Social influence: Compliance and conformity. Annu. Rev. Psychol. (2004). 21. Robert B Cialdini, Raymond R Reno, and Carl A Kallgren. 1990. A focus theory of normative conduct: recycling the concept of norms to reduce littering in public places. J. Pers. Soc. Psychol. (1990). 22. CNN. n.d. Community Guidelines. http://cnn.it/1WAhxh5. (n.d.). 23. John P Davis, Shelly Farnham, and Carlos Jensen. 2002. Decreasing online'bad'behavior. In Proc. SIGCHI Extended Abstracts. 24. Nicholas Diakopoulos and Mor Naaman. 2011. Towards quality discourse in online news comments. In Proc. CSCW. 25. Discourse. n.d. This is a Civilized Place for Public Discussion. http://bit.ly/1TM8K5x. (n.d.). 26. Judith S Donath. 1999. Identity and deception in the virtual community. Communities in Cyberspace (1999). 27. Maeve Duggan. 2014. Online Harassment. Pew Research Center (2014). 28. Klint Finley. 2015. A brief history of the end of the comments. http://bit.ly/1Wz2OUg. (2015). 29. Joseph P Forgas and Gordon H Bower. 1987. Mood effects on person-perception judgments. J. Pers. Soc. Psychol. (1987). 30. Becky Gardiner, Mahana Mansfield, Ian Anderson, Josh Holder, Daan Louter, and Monica Ulmanu. 2016. The dark side of Guardian comments. Guardian (2016). 31. Francesca Gino, Shahar Ayal, and Dan Ariely. 2009. Contagion and differentiation in unethical behavior: the effect of one bad apple on the barrel. Psychol. Sci (2009). 32. Scott A Golder and Michael W Macy. 2011. Diurnal and seasonal mood vary with work, sleep, and daylength across diverse cultures. Science (2011). 33. Roberto Gonz´alez-Ib´anez and Chirag Shah. 2012. Investigating positive and negative affects in collaborative information seeking: A pilot study report. In Proc. ASIST. 34. Jeff Greenberg, Linda Simon, Tom Pyszczynski, Sheldon Solomon, and Dan Chatel. 1992. Terror management and tolerance: Does mortality salience always intensify negative reactions to others who threaten one's worldview? J. Pers. Soc. Psychol. (1992). 35. The Guardian. n.d. Community Standards and Participation Guidelines. http://bit.ly/1YtIxfW. (n.d.). 36. Noriko Hara, Curtis Jay Bonk, and Charoula Angeli. 2000. Content analysis of online discussion in an applied educational psychology course. Instr. Sci. (2000). 37. Claire Hardaker. 2010. Trolling in asynchronous computer-mediated communication: From user discussions to academic definitions. J. Politeness Res. (2010). 38. Susan Herring, Kirk Job-Sluder, Rebecca Scheckler, and Sasha Barab. 2002. Searching for safety online: Managing" trolling" in a feminist forum. The Information Society (2002). 39. Chiao-Fang Hsu, Elham Khabiri, and James Caverlee. 2009. Ranking comments on the social web. In Proc. CSE. 40. Clayton J Hutto and Eric Gilbert. 2014. Vader: A parsimonious rule-based model for sentiment analysis of social media text. In Proc. ICWSM. 41. John W Jones and G Anne Bogat. 1978. Air pollution and human aggression. Psychol. Rep. (1978). 42. Laura June. 2015. I'm Voting for Hillary Because of My Daughter. http://thecut.io/1rNEeBJ. (2015). 43. Joseph M Kayany. 1998. Contexts of uninhibited online behavior: Flaming in social newsgroups on Usenet. J. Am. Soc. Inf. Sci. (1998). 44. Dacher Keltner, Phoebe C Ellsworth, and Kari Edwards. 1993. Beyond simple pessimism: effects of sadness and anger on social perception. J. Pers. Soc. Psychol. (1993). 45. Philip C Kendall, W Robert Nay, and John Jeffers. 1975. Timeout duration and contrast effects: A systematic evaluation of a successive treatments design. Behavior Therapy (1975). 46. Peter G Kilner and Christopher M Hoadley. 2005. Anonymity options and professional participation in an online community of practice. In Proc. CSCL. 47. Ben Kirman, Conor Lineham, and Shaun Lawson. 2012. Exploring mischief and mayhem in social computing or: how we learned to stop worrying and love the trolls. In Proc. SIGCHI Extended Abstracts. 48. Silvia Knobloch-Westerwick and Scott Alter. 2006. Mood adjustment to social situations through mass media use: How men ruminate and women dissipate angry moods. Hum. Commun. Res. (2006). 49. Agata Kołakowska. 2013. A review of emotion recognition methods based on keystroke dynamics and mouse movements. In Proc. HSI. 50. Adam DI Kramer, Jamie E Guillory, and Jeffrey T Hancock. 2014. Experimental evidence of massive-scale emotional contagion through social networks. PNAS (2014). 51. Travis Kriplean, Jonathan Morgan, Deen Freelon, Alan Borning, and Lance Bennett. 2012a. Supporting reflective public thought with considerit. In Proc. CSCW. 52. Travis Kriplean, Michael Toomim, Jonathan Morgan, Alan Borning, and Andrew Ko. 2012b. Is this what you meant?: promoting listening on the web with reflect. In Proc. SIGCHI. 53. Cliff Lampe and Paul Resnick. 2004. Slash (dot) and burn: distributed moderation in a large online conversation space. In Proc. SIGCHI. 54. Hangwoo Lee. 2005. Behavioral strategies for dealing with flaming in an online forum. Sociol Q (2005). 55. So-Hyun Lee and Hee-Woong Kim. 2015. Why people post benevolent and malicious comments online. Commun. ACM (2015). 56. Karen Pezza Leith and Roy F Baumeister. 1996. Why do bad moods increase self-defeating behavior? Emotion, risk tasking, and self-regulation. In J. Pers. Soc. Psychol. 57. Jerome M Levine and Gardner Murphy. 1943. The learning and forgetting of controversial material. J. Abnorm. Soc. Psychol. (1943). 58. Tanya Beran Qing Li. 2005. Cyber-harassment: A study of a new method for an old behavior. In J. Educ. Comput. Res. 59. Nina Mazar, On Amir, and Dan Ariely. 2008. The dishonesty of honest people: A theory of self-concept maintenance. J. Mark. Res. (2008). 60. Brian James McInnis, Elizabeth Lindley Murnane, Dmitry Epstein, Dan Cosley, and Gilly Leshed. 2016. One and Done: Factors affecting one-time contributors to ad-hoc online communities. In Proc. CSCW. 61. DM McNair. 1971. Manual profile of mood states. 62. Stanley Milgram, Leonard Bickman, and Lawrence Berkowitz. 1969. Note on the drawing power of crowds of different size. J. Pers. Soc. Psychol. (1969). 63. Stanley Milgram and Ernest Van den Haag. 1978. Obedience to authority. (1978). 64. Lev Muchnik, Sinan Aral, and Sean J Taylor. 2013. Social influence bias: A randomized experiment. Science (2013). 65. J. Nathan Matias. 2016. Posting Rules in Online Discussions Prevents Problems & Increases Participation. http://bit.ly/2foNQ3K. (2016). 66. Vlad Niculae and Cristian Danescu-Niculescu-Mizil. 2016. Conversational markers of constructive discussions. In Proc. NAACL. 67. Deokgun Park, Simranjit Sachar, Nicholas Diakopoulos, and Niklas Elmqvist. 2016. Supporting Comment Moderators in Identifying High Quality Online News Comments. In Proc. SIGCHI. 68. James W Pennebaker, Martha E Francis, and Roger J Booth. 2001. Linguistic inquiry and word count: LIWC 2001. 69. Adrian Raine. 2002. Annotation: The role of prefrontal deficits, low autonomic arousal, and early health factors in the development of antisocial and aggressive behavior in children. J. Child Psychol. Psychiatry (2002). 70. Juliana Raskauskas and Ann D Stoltz. 2007. Involvement in traditional and electronic bullying among adolescents. Dev. Psychol. (2007). 71. Emmett Rensin. 2014. Confessions of a former internet troll. Vox (2014). 72. Paul R Rosenbaum and Donald B Rubin. 1983. The central role of the propensity score in observational studies for causal effects. Biometrika (1983). 73. Lee Ross. 1977. The intuitive psychologist and his shortcomings: Distortions in the attribution process. Adv. Exp. Soc. Psychol. (1977). 74. James Rotton and James Frey. 1985. Air pollution, weather, and violent crimes: concomitant time-series analysis of archival data. J. Pers. Soc. Psychol. (1985). 75. Paul Rozin and Edward B Royzman. 2001. Negativity bias, negativity dominance, and contagion. Pers. Soc. Psychol. Rev. (2001). 76. Matthew J Salganik, Peter Sheridan Dodds, and Duncan J Watts. 2006. Experimental study of inequality and unpredictability in an artificial cultural market. Science (2006). 77. Mattathias Schwartz. 2008. The trolls among us. NY Times Magazine (2008). 78. Norbert Schwarz and Herbert Bless. 1991. Happy and mindless, but sad and smart? The impact of affective states on analytic reasoning. Emotion and Social Judgments (1991). 79. Norbert Schwarz and Gerald L Clore. 1983. Mood, misattribution, and judgments of well-being: informative and directive functions of affective states. J. Pers. Soc. Psychol. (1983). 80. Pnina Shachaf and Noriko Hara. 2010. Beyond vandalism: Wikipedia trolls. J. Inf. Sci. (2010). 81. Muzafer Sherif, Oliver J Harvey, B Jack White, William R Hood, Carolyn W Sherif, and others. 1961. Intergroup conflict and cooperation: The Robbers Cave experiment. 82. Robert Slonje, Peter K Smith, and Ann Fris´eN. 2013. The nature of cyberbullying, and strategies for prevention. Comput. Hum. Behav. (2013). 83. Abhay Sukumaran, Stephanie Vezich, Melanie McHugh, and Clifford Nass. 2011. Normative influences on thoughtful online participation. In Proc. SIGCHI. 84. John Suler. 2004. The online disinhibition effect. Cyberpsychol. Behav. (2004). 85. Peter C Terry and Andrew M Lane. 2000. Normative values for the Profile of Mood States for use with athletic samples. J. Appl. Sport Psychol. (2000). 86. Kris Varjas, Jasmaine Talley, Joel Meyers, Leandra Parris, and Hayley Cutts. 2010. High school students perceptions of motivations for cyberbullying: An exploratory study. West. J. Emerg. Med. (2010). 87. Lu Wang and Claire Cardie. 2014. A Piece of My Mind: A Sentiment Analysis Approach for Online Dispute Detection. In Proc. ACL. 88. Yang Wang, Gregory Norcie, Saranga Komanduri, Alessandro Acquisti, Pedro Giovanni Leon, and Lorrie Faith Cranor. 2011. I regretted the minute I pressed share: A qualitative study of regrets on Facebook. In Proc. SUPS. 89. Ladd Wheeler. 1966. Toward a theory of behavioral contagion. Psychol. Rev. (1966). 90. David Wiener. 1998. Negligent publication of statements posted on electronic bulletin boards: Is there any liability left after Zeran? Santa Clara L. Rev. (1998). 91. Robb Willer, Ko Kuwabara, and Michael W Macy. 2009. The False Enforcement of Unpopular Norms. Am. J. Sociol. (2009). 92. James Q Wilson and George L Kelling. 1982. Broken Windows. Atlantic Monthly (1982). 93. Carrie L Wyland and Joseph P Forgas. 2007. On bad mood and white bears: The effects of mood state on ability to suppress unwanted thoughts. Cognition and Emotion (2007). 94. Justine Zhang, Ravi Kumar, Sujith Ravi, and Cristian Danescu-Niculescu-Mizil. 2016. Conversational flow in Oxford-style debates. In Proc. NAACL. 95. Philip G Zimbardo. 1969. The human choice: Individuation, reason, and order versus deindividuation, impulse, and chaos. Nebr. Symp. Motiv. (1969).
1502.05149
1
1502
2015-02-18T08:01:29
Using multiple-criteria methods to evaluate community partitions
[ "cs.SI", "physics.soc-ph" ]
Community detection is one of the most studied problems on complex networks. Although hundreds of methods have been proposed so far, there is still no universally accepted formal definition of what is a good community. As a consequence, the problem of the evaluation and the comparison of the quality of the solutions produced by these algorithms is still an open question, despite constant progress on the topic. In this article, we investigate how using a multi-criteria evaluation can solve some of the existing problems of community evaluation, in particular the question of multiple equally-relevant solutions of different granularity. After exploring several approaches, we introduce a new quality function, called MDensity, and propose a method that can be related both to a widely used community detection metric, the Modularity, and to the Precision/Recall approach, ubiquitous in information retrieval.
cs.SI
cs
Using multiple-criteria methods to evaluate community partitions Cazabet Remy,∗ Chawuthai Rathachai, and Takeda Hideaki National Institute of Informatics 2-1-2 Hitotsubashi, Chiyoda-ku,Tokyo, Japan (Dated: May 31, 2021) Community detection is one of the most studied problems on complex networks. Although hun- dreds of methods have been proposed so far, there is still no universally accepted formal definition of what is a good community. As a consequence, the problem of the evaluation and the comparison of the quality of the solutions produced by these algorithms is still an open question, despite con- stant progress on the topic. In this article, we investigate how using a multi-criteria evaluation can solve some of the existing problems of community evaluation, in particular the question of multiple equally-relevant solutions of different granularity. After exploring several approaches, we introduce a new quality function, called MDensity, and propose a method that can be related both to a widely used community detection metric, the Modularity, and to the Precision/Recall approach, ubiquitous in information retrieval. I. INTRODUCTION A. Single score metrics Community detection is one of the most studied prob- lems on complex networks. Countless papers have been published on this topic, in particular during the last 15 years. However, most of this publication frenzy has been centered on the problem of proposing new methods. As the number of proposed methods increased, the problem of comparing them became more and more im- portant. As a consequence, some of the most influential works on the subject propose methods to compare par- titions between themselves. As the number of scalable methods increases, the question of which method to use becomes more and more important. In this paper, we will first review some of the exist- ing methods to evaluate the quality of a partition. In a second section, we will discuss on what are good commu- nities and good partitions, and will argue for the inter- est of using a two-criteria approach. Finally, we will go step by step from a two-criteria method directly inspired from information retrieval techniques to a more relevant method grounded on the Modularity. II. EVALUATION METHODS Several techniques have already been proposed to com- pare partitions -- and therefore the algorithms that pro- duced them -- between themselves. We can classify these methods in three families: • Single score metrics • Evaluation on generated networks • Evaluation on real networks with ground truth We will review in the next sections these three types of evaluation methods ∗ [email protected] Single score metrics are using quality functions associ- ating a score to a given partition of a given network. To compare two partitions on a same network, one can sim- ply compare their scores according to this quality func- tion. Historically, the ancestor of community detection is the problem of graph partitioning -- finding sets of nodes of predefined sizes such as the number of edges between them is minimum. In this problem, the quality function was simply the number of edges between communities. As this metric loses its significance as soon as we do not fix the size and number of the clusters to find, different metrics are used to evaluate the quality of community partitions. Several of these metrics are detailed in [1], while [2] compares some of them on real cases. However, the quality function that is by far the most popular is the Modularity. Initially introduced in [3], this quality function is defined as the difference between the ratio of edges that fall inside communities and the expected value in a randomized version of the network. We will talk in details of the Modularity in the later sections of this arti- cle. It is now so popular that it is sometimes considered and used as a definition of communities. However, since the demonstration of its resolution limit [4], the usage of the sole Modularity to evaluate communities is discour- aged. Adaptations of the Modularity called resolution- free methods have been proposed, notably in [5, 6], but have also been criticized. Surprise [7] is another interest- ing function proposed recently, measuring how unlikely is a given partition compared to a null model. Using a single score metric to evaluate communities has advantages: • One can compare partitions not only on networks with a known solution but on any particular net- work of interest for him. • For any network, a best solution can be unambigu- ously identified. But also some drawbacks: • Using a quality function is using a fix definition of what is a community. However, this definition is arbitrary, as there is no consensus of the topic. • On real networks, quality functions are likely to have only one maximal value. However, it is known that networks can have several meaningful levels of decomposition. Among several potential problems raised by this observation, a perfect partition at a suboptimal level might get a lower score than an imperfect decomposition at the optimal level. B. Evaluation on generated networks This approach consists in generating random networks with a well-defined community structure, known by con- struction, running several algorithms on these networks, and check how well the partitions found match the ex- pected ones. From ad-hoc methods such as the one used in [3], more advanced network generators have been pro- posed. The LFR benchmark [8] is the most widely used, it allows to tune several parameters such as the num- ber of nodes, average degrees, distribution of the size of communities, and so on and so forth. To compare the so- lutions found to the reference, the most widely used func- tion is the Normalized Mutual Information [9], but other approaches are possible, such as topological approaches [10], or cluster-analysis methods modified to take into account the network structure [11]. Advantages: • Although proposing networks with a community structure requires a loose definition of what is a community, consensual results are easier to reach than in a quality function, where the definition is formal. It is easier to recognize a good community when we saw one that to give a universal definition. • Variations on usual communities, such as hierar- chical decomposition, fuzzy communities or over- lapping communities can be tested. Drawbacks: • Nothing guaranties that the networks and commu- nities generated are realistic. This means that some algorithms might be more (or less) efficient on these generated networks than on real ones. • This category of evaluation aim at finding a univer- sally most efficient algorithm. By varying the pa- rameters of the network, it might be possible to re- fine this classification, some algorithms being more efficient for dense networks, or small communities for instance, but the algorithms efficiencies are not evaluated on the particular graph that one wants to study. 2 C. Evaluation on real networks with ground truth One solution to the problem of unrealistic networks and community structures of generated networks is to work with real networks and real communities. This was the idea of the first evaluations, using small networks such as the Zachary karate club [12] or Lusseaus dol- phins network [13], on which the communities found can be compared to a known real decomposition, or be stud- ied graphically or intuitively. However, transposing this method to networks with a larger scale wasn't possible for a long period. Recently, some adequate networks were proposed, such as in [2, 14]. In [15], a slightly different approach is proposed: instead of comparing partitions to a priori ground truth, experts assign relative and abso- lute scores to several solutions on a same network. However, these methods also have weaknesses, as dis- cussed in [16] for instance. The problem is that this approach compares solutions that are purely topological with ground truths that depend on much more factors. It is for instance possible to have a ground truth community composed of several connected components, a situation that does not make sense on a topological perspective. Other advantages and drawbacks are similar to those of the method using generated networks. To put it in a nutshell, whereas the network properties are no longer a concern, the solution of reference becomes less reliable, and this approach can only be used to pick an universally best performing method. D. Potential advantages of a multiple-criteria quality function As we have seen in the previous section, using a qual- ity function to evaluate community structures has the important advantage of evaluating partitions on a given network of interest, instead of searching for an universally superior algorithm. In the most common application of community detection, one wants to study a given net- work, knows several methods applicable to it, but does not know which one to use. The quality function can tell him which algorithm is the most efficient on his net- work. However, we know that with a single metric, the choice will be arbitrary, because it is possible on net- works to have several relevant community structures of different granularities, and one of these solutions will, in the general case, have a higher quality score than the others. By using a multiple-criteria function and the notion of Pareto optimality, we will be able to identify several potentially relevant solutions, defined as all so- lutions present on the Pareto frontier. The property of these solutions is that no other solution is superior to them in all considered criteria. The preference for one of these solutions relatively to others can still be decided by attributing weights to the considered criteria. In the following sections, we will propose some possible relevant criteria. 3 (a) LFR, µ=0.5 (b) DicoSyn FIG. 1: Visualization of Precision and Recall for several algorithms III. A FIRST APPROACH: COMMUNITY DETECTION AS A CLASSIFICATION PROBLEM To propose a new method for community evaluation, we need to go back to the definition of what is a good community. The consensual definition, widely accepted, is that a good community structure must identify groups of nodes that are well connected between themselves, while having few edges between the groups. The key idea that we will explore in this paper is that communities are defined as a trade-off between two ob- jectives, having communities as dense as possible, and as well separated as possible from the rest of the network. Creating well-separated communities, without other constraint, is simple. By increasing the size of commu- nities, we can add as many edges as we want in them. The optimal solution for the separation objective is to define communities as the connected components of the network, resulting in the absence of edges between com- munities. In a similar fashion, without other constraint, it is straightforward to define communities as dense as we want. The optimal solution for this objective, reach- able in any network, consists in communities composed of cliques, of size 2 in the worst case, plus a certain num- ber of singletons. All non-singleton communities have a density of 1. Between these two extreme but uninformative solu- tions lie the sought ones. This idea was already present in the graph-partitioning problem, which consist in optimizing the separation while fixing the size of communities. As the intern density depends on the number of intern edges and the size of the communities, this has the consequence of fixing a lower bound on the value of the intern density. This idea is again central in the common definitions of communities, such has the conductance [17], defined as the ratio of extern edges over intern edges, or the modu- larity, in a more indirect fashion. However, when comparing partitions, these two oppo- site objectives are usually merged in a single metric, to determine which solution is better than all the others. As discussed earlier, this is often not pertinent in the case of community detection, as several meaningful levels of decomposition might exist. The problem is to decide which metrics can we use to meaningfully represent the separation and the definition. In the coming chapter, we will propose a first simple ap- proach, and discuss its strengths and weaknesses. A. Precision and Recall One of the most common uses of a twofold metric to evaluate the result of an algorithm can be found in the classification problem, through the usage of Precision and Recall. The first approach we propose is simply to con- sider the problem of community detection as a classifica- tion problem, allowing us to evaluate it as such. We can define the problem as follows: for an undi- rected, not oriented graph G = (V, E), the instances to classify are all the vertex pairs of the network, V P = {(i, j) : i ∈ V, j ∈ V, i (cid:54)= j}. The two categories are: EDGE : {vp ∈ V P : vp ∈ E} NOTEDGE : {vp ∈ V P : vp /∈ E} A community detection algorithm is therefore seen as a classifier to recognize vertex pairs that are the more likely to belong to E. This definition makes sense relatively to the definition of community detection: communities must be dense, and few edges must fall between communities, a community detection tries to leave as less edges outside of the communities, while having as less non-edges inside communities as possible. 0.250.300.350.400.450.500.000.010.020.030.04PrecisionRecallfactor(method)eigenfgim1louvainrealwt0.60.81.00.0000.0250.0500.0750.100PrecisionRecallfactor(method)eigenfgim1louvainwt To keep close with the classification problem, we split E in a training set and a validation set. In our experi- ments, we create a graph Gtraining, corresponding to an original graph G from which we remove a percentage P of its edges. These removed edges RE constitute part of the val- idation set V S. However, the validation set must be representative of the training set used by the algorithm, which was composed of vertex pairs, not only of edges of G. Therefore, our validation set must be composed of both. The vertex pairs not belonging to E are essen- tial to compute the rate of false positives, edges that fall inside communities but do not belong to G. The total number of vertex pairs in the validation set is equal to V S = P ∗V P, and is composed of {RE ∪ F P T}, with F P T a random selection of potential edges taken from {V P \ E}, with size F P T = V S − RE Precision and Recall are computed according to their usual definition. As a reminder, they are defined as: P recision = T P Recall = T P with TP = True Positive, FP = False Positive and FN = False Negative T P +F N T P +F P C : set of all communities n : number of nodes in a graph m : number of edges in a graph lc : number of edges inside community c l : number of edges inside all communities l(cid:48) c : number of edges inside community c according to a null model l(cid:48) : number of edges inside all communities according to a null model kc : number of vertex pairs inside community c k : number of vertex pairs inside all communities p : number of vertex pairs in the whole graph TABLE I: Notations 1. Network interpretation of Precision and Recall In the context of community detection, Precision and Recall can be written as a more traditional, network- centered approach. To simplify, we will not make a dif- ference between the test set and the whole network. On the whole network, the Recall corresponds to the fraction of all edges that fall inside communities. This value is of- ten used in evaluating community detection, for instance in the Modularity, defined as the difference between this observed ratio and the expected ratio in a null model. Precision corresponds to the ratio of edges inside com- munities over the number of vertex pairs inside communi- ties, i.e the global density of communities. More formally, 4 on the whole network: P recision = l k , Recall = l m To keep the equations simple, we will use the notations of Table I for all equations relative to communities. 2. Precison and Recall to evaluate communities Fig. 1 is an illustration of the results with five widely used algorithms, on a real graph and a generated graph produced by using the LFR benchmark [8]. The networks used are: • LFR, µ = 0.5: a network generated with the LFR benchmark, with standard parameters and a mix- ing parameter µ = 0.5. Communities are still well defined, but most algorithms already fail to identify them. n = 5000, m = 50000 • DicoSyn [18][19]: a synonymy network, nodes rep- resent verbs and edges proximity in meaning. We chose this network because it is easily interpretable, and one can observe by comparing different algo- rithms that partitions with high modularity seem less relevant than some solutions of lower modular- ity. n = 9146, m = 51423 The methods used are: • eigen: The eigenvector decomposition method de- scribed in [20], as implemented in the igraph pack- age [21]. • fg: The fastgreedy modularity optimization method, described in [22], as implemented in the igraph package. It provides a hierarchical decom- position. • wt: The walktrap algorithm, described in [23], as implemented in the igraph package. • im: The infohiermap method, described in [24], as implemented by the authors. Can identify several levels. • louvain: The louvain method, described in [25], as implemented by the authors. Can identify several levels. For each network, we generated 20 different test sets, and run each algorithm on each of these test sets. Indi- vidual results are displayed as a small dot, and a large dot corresponds to the average values. For methods produc- ing several solutions, we consider only the default one. On the generated graph, we can observe that only two methods, infomap and louvain, are on the Pareto frontier, the other ones being outperformed on both aspects at least by infomap. The solution proposed by the louvain method has a higher Recall than the infomap method, but a lower precision. The correct decomposition is also on the Pareto frontier. On the real graph DicoSyn, it seems more difficult for a solution to outperform most others. Instead, each method is superior to other ones on one aspect, but in- ferior in another one. The eigen method is the only one to be outperformed. These examples illustrate the interest of a multi- objective approach: • It is possible to compare algorithms on a particular graph, and not only on test graphs • It is possible to eliminate some methods as Pareto dominated • It is also possible to keep several partitions as po- tential solutions, and to choose the most interesting one depending on our objective 3. Limits of the Precision and Recall method By using the typical definition of Precision and Recall, we have a first solution for the evaluation of the quality of partitions. However, this method has clearly some weak- nesses. First, community detection is not usually defined as a classification problem, and there is no guaranty for these metrics to correctly recognize good communities. The second weakness is that we can easily add a large number of partitions on the Pareto frontier, even though these partitions are clearly not relevant in term of com- munities. We can show that, starting from a Pareto optimal partition P , we can in most cases generate a new valid partition P (cid:48) with either a higher Precision or a higher Recall. A higher Recall can be obtained by merging communities having edges between their nodes (increase in l, m stays constant). A higher Precision can be reached, for instance, by splitting sparse communities in cliques of size at least 2. Note that the resulting solu- tions are not necessarily Pareto optimum for the graph, it could be possible to find a solution Pareto dominant to them, but they are not Pareto dominated by P . To put it in a nutshell, the problem of this method is that it is too simple to generate irrelevant solutions on the Pareto frontier. In fact, this problem is linked to the size of the communities found: a partition composed of large communities will tend to have a high Recall and a low Precision, and vice versa. In the next section, we will propose a solution taking into account this problem of the size of communities. 4. Single run versus several runs In this first approach, because we wanted to stay as close as possible from the classification problem, we used a training set and a test set. However, as our problem is not really a classification problem, there is no need 5 to do so, and we could compute the values of Precision and Recall on the whole network. For the other solu- tions presented on this paper, we will directly compute solutions on the whole network, and compute our criteria accordingly. However, we can note that the idea of evalu- ating several runs on a slightly randomized version of the network can nevertheless be interesting, because of the known problem of the instability of the algorithms[26]: a same algorithm, when confronted to two slightly dif- ferent versions of a same network, can converge to very different partitions. IV. SIZE, SEPARATION AND MODULARITY The method presented in the previous section has the drawback of not being directly grounded on the tradi- tional works on community detection. In this section, we will propose another approach which is based on a generalization of the graph partitioning problem, and we will show that this approach is directly related to the most widely used quality function in community detec- tion, Modularity. A. Graph partitioning generalization The ancestor of community detection is the problem of graph partitioning. This problem can be expressed in the following manner: for a given network and a given number of clusters of similar sizes, the best partition is the one that will result in a minimum number of edges laying between clusters. It is necessary to fix the number and size of the objective clusters, otherwise minimizing inter-cluster edges is achieved by a trivial solution, such as leaving only the node of lower degree in a community and all other nodes in another. As the number of extern edges is the opposite of the number of intern edges, a typical measure of the quality of a partition for commu- nities of fixed properties can be unambiguously defined as: Qpartitioning = 1 − m − l m = l m = Recall Which is identical to the Recall defined in the first chap- ter. However, two partitions can only be compared ac- cording to this metric if they are composed of clusters of similar sizes. The problem of community detection can be seen as a generalization of graph partitioning, search- ing for the best partition not only for fixed properties of communities, but for the best solution considering all possible combinations of number and size of communi- ties. The two opposite metrics that we propose to use are therefore Qpartitioning and an indicator of the size of com- munities, which corresponds to the difficulty of having intra-community edges. The more vertex pairs are inside 6 (a) LFR, µ = 0.5 (b) DicoSyn FIG. 2: Visualization of the ratio of intern edges and size of communities communities, the easier to have edges inside communi- ties. To represent the size of the communities, we want to use a metric between 0 and 1, with 0 corresponding to the largest communities, for which a maximal value of Qpartitioning can be reached. We use the fraction of vertex pairs that fall outside communities: instead of the raw Qpartitioning value, it is no longer pos- sible to provide trivial solutions by merging communities of an initial partition, as these trivial solutions will come closer to the baseline, if they are not relevant, and there- fore have a lower Q(cid:48). cSize = 1 − k p We can remark that this metric is related to diver- sity indexes: small values will correspond to larger, more uneven clusters than large values. Said differently, the closer we get to a single cluster containing all nodes, the less useful information the partition contains about the modular structure of the network. Fig. 2 is a visualization of these two metrics on the same networks used in the previous section. This time, we display all levels of decomposition provided by hier- archical algorithms. One interesting property is that, if the graph was a random one, the proportion of edges in- side communities will be linearly proportional to the pro- portion of vertex pairs inside communities. Therefore, on a random graph, there is a relation Qpartitioning = 1−cSize. We represent this relation as a straight dashed line in our graph. Using this random case as a baseline allows us to bal- ance the improvement in Qpartitioning when augmenting the size of communities relatively to the mechanical im- provement due to the higher number of vertex pairs be- tween communities. By taking the difference between the separation produced by the partition and the baseline, we can have a measure of the improvement yielded by this partition. This function Q(cid:48) can be defined as: Q(cid:48) = Qpartitioning − l(cid:48) m This is a partial solution to the problem we encountered if we consider Q(cid:48), using the Precision/Recall approach: B. Relation with the Modularity Modularity is usually defined as a sum over all edges or a sum over communities. However, using our notation, it can also be written as: M odularity = − l(cid:48) m l m Where l(cid:48) corresponds to the expected number of edges according to a null model. As a consequence, if the same null model is used, Q(cid:48) is strictly equivalent to the Mod- ularity. Previous works have shown that a better null model consists of a random network of same degree dis- tribution than the original graph. We can adapt our solution to this improvement. 1. Modularity Decomposition Graph Based on the previous observations, we can propose a variation of the Qpartitioning and cSize criteria. We already proposed to replace Qpartitioning by Q(cid:48), and we have just seen that using the typical Modularity was an improvement over it. However, we must also change the cSize accordingly. By using the property k m in a random graph, we can define our modified cSize, that we call Corrected Community Size (CCS) as: p = l(cid:48) CCS = 1 − l(cid:48) m = 1 − (Qpartitioning − M odularity) 0.00.20.40.60.50.60.70.80.91.0cSizeRecallmethodeigenfg#im#louvain#realwt0.00.20.40.60.80.50.60.70.80.91.0cSizeRecallmethodeigenfg#im#louvain#wt 7 (a) LFR, µ = 0.5 (b) DicoSyn FIG. 3: Visualization of the Modularity Decomposition Graph rect solution was always the solution of highest modular- ity, despite the so-called resolution limit. This is because, with the parameters most commonly used in the litera- ture, the communities are in the correct resolution for modularity. To avoid this bias, we generated a network with the LFR benchmark using the following parameters: • Number of nodes: 50000 • µ: 0.5 • Size of communities : [11,11] • Average degree: 20 • Maximal degree: 20 FIG. 4: Modularity Decomposition Graph on a generated network where the maximum of modularity do not match with the researched solution The idea of this measure is similar to the cSize, it repre- sents how big communities are in term of the probability of containing links, but this time considering the degrees of their nodes. Fig. 3 represents the score of partitions using the same algorithms and graphs than previously. A consequence of using these two metrics to define a Pareto frontier is that, if we know the solution of maximal mod- ularity, it is not possible to find a value on the Pareto frontier with a value of CCS below the value correspond- ing to the modularity optimum, that is to say, it is not possible to find a Pareto optimal solution with "larger" communities than the solution of maximal modularity. As a consequence, in the LFR example, most solutions become Pareto-dominated by the correct partition known by construction. Note that the LFR benchmark is not fully appropriate to generate this kind of large graphs with small, dense communities, because of its universal µ value for each node. This is the reason for our choice to generate cliques of fixed size, and to set the degrees of nodes accordingly. Although unrealistic, this is not a major concern for our purpose, as we are just interested in obtaining a clear community partition with suboptimal modularity score, and not to compare community detection algorithms on realistic networks. The results of this graph are shown in Fig. 4. We can observe that, although both Louvain and InfoMap found the correct decomposition, the Louvain method also identifies solutions of higher modularity, but of larger size. The fast greedy method identifies a solution with a Modularity score relatively close to the optimum, but very far in term of the size of communities. 2. Limitations of the Modularity Decomposition Graph While working with networks generated by the LFR benchmark, we were surprised to observe that the cor- Compared to the first multiple-criteria approach that we proposed, the Modularity Decomposition has several 0.00.10.20.30.40.50.60.70.80.91.0CCSmodularitymethodeigenfg#im#louvain#realwt0.00.20.40.50.60.70.80.91.0CCSmodularitymethodeigenfg#im#louvain#wt0.20.30.40.50.9000.9250.9500.9751.000CCSmodularitymethodfg#im#louvain#realwt 8 (a) LFR, µ = 0.5 (b) DicoSyn (c) LFR, µ = 0.5, suboptimal Modularity (d) Zachary karate club (e) LFR µ = 0.3, 2 levels. infomap's solution is identical to the real decomposition of lower modularity, walktrap's solution is identical to the other real decomposition. FIG. 5: Comparison of partitions using Modularity and MDensity 0.00.10.20.30.40.0000.0050.0100.015MDensitymodularitymethodeigenfg#im#louvain#realwt0.00.20.40.0000.0050.0100.0150.020MDensitymodularitymethodeigenfg#im#louvain#wt0.00.10.20.30.40.50.00.10.20.30.4MDensitymodularitymethodfg#im#louvain#realwt0.00.10.20.30.40.000.050.10MDensitymodularitymethodeb#eigenfg#im#louvain#wt0.00.10.20.30.40.50.000.050.100.15MDensitymodularitymethodfg#im#louvain#real#wt advantages: it is directly based on the Modularity, a strongly established quality function for partitions, and it does not allow to add points on the Pareto front by gener- ating arbitrarily large communities. Compared to using the sole Modularity, it allows differentiating between sub- optimal but pertinent partitions -- with a value of modu- larity below the optimum but corresponding to "smaller" communities -- and suboptimal partitions, yielding solu- tions not on the Pareto frontier. However, this method still has some drawbacks: first, it is still possible to find trivial solutions by proposing arbitrarily small communities. Secondly, as seen on Fig. 4, this solution might not help us to prefer the correct solution over the solution of optimal modularity when relevant. Whereas the correct solution is on the Pareto frontier, the gain in CCS is of an order of magnitude comparable to the loss in the Modularity. V. MODULARITY AND MDENSITY The Modularity is a method based on the comparison of the ratio of extern (or intern) edges to a null model. As so, this metric is clearly a descendant of the partitioning problem. However, compared to the traditional, infor- mal definition of communities, which states a trade-off between clearly separated and well defined communities, it seems that the modularity alone is biased -- for sparse networks -- toward an optimization of the separation of communities, at the cost of a poor definition. This phe- nomenon is a consequence of the limit of resolution of the modularity, and should be balanced by a symmetri- cal measure ensuring the optimization of the density of the communities. The modularity is a measure of the improvement of the separation of communities -- the ratio of inter-community edges -- over a null model. We introduce the Module- Density, or MDensity, which is the improvement of the density of communities over a null model, pondered by the separation. A. Introducing MDensity We can start by computing the overall improvement in modularity over a null model, defined as the sum for each community of its gain in density pondered by its relative size in terms of number of pairs: C(cid:88) (cid:18) lc kc c=1 DensityGain = (cid:19) − l(cid:48) c kc ∗ kc k = l − l(cid:48) k However this function has trivial maximal solutions, communities composed of cliques, we therefore balance it by the ratio of intern edges inside communities, : M Density = l − l(cid:48) k ∗ l m 9 We can then conveniently express the MDensity from the Modularity, which gives us another interpretation of the MDensity as the modularity balanced by the density. M Density = ∗ M odularity l k However, one of the interesting features of the Mod- ularity is that it uses a null model based on the preser- vation of the degree distribution. We want to also in- tegrate this feature in the MDensity. The intuition is that a higher density can be reached more easily between nodes of high degrees, and is therefore less significative than between nodes of low degrees. We have defined l(cid:48) as the number of edges expected in communities. As edges are distributed at random, we can define k(cid:48) = l(cid:48)∗p m , the degree-corrected number of vertex pairs inside communi- ties based on the chosen null model. Our final definition of MDensity is now: M Density = l − l(cid:48) k(cid:48) ∗ l m To understand the difference in nature between MDen- sity and Modularity, we can compare what does a maxi- mal score corresponds to for these two metrics. In both cases, a maximal score can be obtained only if the dif- ference between the number of intern edges and the ex- pected number of edges according to the null model is maximal. If we consider an infinite network with com- munities of finite size, the number of expected edges will tend to zero, maximizing this difference. As the sum of this difference is divided by the total number of edges for the modularity, any decomposition of an infinite net- work in connected components of finite size will result in a maximal score of Modularity of 1, whatever the properties of these connected components. We can imag- ine them as arbitrarily long chains with arbitrarily large cliques at their extremities for instance, which is prob- ably not what most people will recognize as good com- munities. On the contrary, for the MDensity to be equal to 1, it is necessary that all communities have a density of one. As a consequence, a perfect score of MDensity can be reached in an infinite graph only if we can find communities defined as cliques without any links between them. Fig. 5 presents the results on the same graphs as pre- viously, plus the Zachary karate club and a generated network with 2 hierarchical levels. We can see that us- ing these metrics often allows us to eliminate much of the proposed partitions, as not Pareto optimal. Even though the fast greedy Modularity optimization method proposes a complete hierarchy of solutions, none of them manage to be on the Pareto frontier. Each network result seems relevant: • For the LFR benchmark, the correct solution is, as expected, on the top right area, only challenged by the infomap solution. • For the DicoSyn network, the infomap solution, qualitatively identified as more relevant, sees its slightly lower Modularity compensated by a large MDensity score. The profile of this plot is interest- ingly similar to the next one. • For LFR with suboptimal Modularity solution, the researched solution is the only one to have both a high Modularity and MDensity. • For the Zachary karate club, as the network is small, we also represented the partitions obtained by the original edge betweenness algorithm by Gir- van and Newman [3], identified as eb. The solution of maximal modularity found by the louvain algo- rithm corresponds to the partition in 4 communi- ties, often considered the most relevant. Despite the large quantity of partitions considered in this case, this solution is the only Pareto optimal one. • For the generated network with hierarchical com- munities, the two solutions are on the Pareto fron- tier, one with higher modularity and the other with higher MDensity. Different algorithms find one or the other of these solutions, illustrating the interest of our 2-criteria approach. B. Relation to Precision/Recall If we step back to our first approach, using Precision and Recall, and we compare to the couple Modularity and MDensity, we can now observe that there is a rela- tion between them. The Modularity, as already stated, corresponds to the improvement between the observed value of Recall and the Recall of a similar partition in a random network. The MDensity can be defined as the Precision multiplied by the Modularity. VI. IDENTIFYING BEST SOLUTIONS Contrary to the previous approach, in the generated graphs with a solution of suboptimal modularity, the gain of the correct solution in MDensity is much higher than the gain in Modularity of the other solutions of the Pareto frontier. We can use this fact to propose a combination of the two criteria in a single quality function. Of course, by doing so, we fall again in the problems of single criterion metrics described in introduction. As a consequence, we prefer to include in this metric a parameter α ∈ [0, 1], which describes the relative importance we attribute to each criterion. Our combined quality function, 2FQ, for Two Fold Quality, is defined as: 2F Q = αM odularity ∗ (1 − α)M Density On the network of suboptimal modularity, we can now compute that the researched partition has the highest 10 value of 2FQ for α ∈ [0, 0.965], which means that it will be considered as the best solution, unless we choose α > 0.965, corresponding to a choice mostly considering the separation of the communities, and not their density. We have to stress that the intervals of α corresponding to maximal 2FQ are only relative to the tested parti- tions, and that other partitions might exist that would completely modify them. The length of the interval also has no meaning, unless we know all the solutions on the Pareto frontier. VII. CONCLUSION In this article, we presented a new approach to evalu- ate and compare partitions in communities. This method is grounded on the usual definition of communities, de- fined as a trade off between the "internal definition" and the "separation" of the communities. It makes use of an already widely used metric, the Modularity, and we can also relate it to the Precision and Recall approach in classification. Because it has two criteria, it allows identifying several relevant partitions. However, as both criteria do not have trivial solutions, it can drastically limit the number of partitions considered as relevant. This method opens several possibilities for future work, among them: • Adapt it to overlapping communities. This is not trivial, but some works already exist to adapt mod- ularity to overlapping communities, such as [27]. • Adapt existing algorithms of Modularity optimiza- tion for 2FQ optimization, and test the efficiency of such a method on simulated and real benchmarks. • Explore in details the properties of the Pareto max- imal partitions, in the case of clearly or weakly de- fined communities. To conclude, we want to stress the importance of compar- ing several partitions. Community detection is applied in many fields and for many purposes, but one popu- lar usage is to use it on an existing network on which one wants to gain insights, and to interpret the parti- tion found as being an intrinsic property of the studied network. For instance, one can study the sizes of the communities -- or the distribution of their sizes, the num- ber of inter-community edges, or more generally interpret the meaning of such and such nodes being clustered to- gether. This is a perfectly legitimate practice, however, for this usage, each particular community detection algo- rithm having its own definition of what is a community, it appears important to take into consideration several rel- evant solutions, and to check if the observations we get on one partition are confirmed by others. For instance, it appears clearly from our observations and from the reso- lution limit that methods based on modularity optimiza- tion tend to find large, sparse communities when applied to large networks, while other methods could find a com- pletely different but relevant solution composed of much smaller communities. We hope our multiple-criteria ap- proach can be used in such cases to consider several parti- tions, not by applying randomly some algorithms, but by picking the most relevant partitions among several ones. 11 [1] S. Fortunato, Physics Reports 486, 75 (2010). [2] J. Yang and J. Leskovec, in Proceedings of the ACM SIGKDD Workshop on Mining Data Semantics (ACM, 2012) p. 3. [16] D. Hric, R. K. Darst, and S. Fortunato, arXiv preprint arXiv:1406.0146 (2014). [17] J. Leskovec, K. Lang, A. Dasgupta, and M. Mahoney, Internet Mathematics 6, 29 (2009). [3] M. Girvan and M. Newman, Proceedings of the National [18] Network available at the following address: http://dx. Academy of Sciences 99, 7821 (2002). doi.org/10.5281/zenodo.12453". [4] S. Fortunato and M. Barthelemy, Proceedings of the Na- tional Academy of Sciences 104, 36 (2007). [5] A. Arenas, A. Fernandez, and S. Gomez, New Journal of Physics 10, 053039 (2008). [6] J. Reichardt and S. Bornholdt, Physical Review E 74, 016110 (2006). [7] R. Aldecoa and I. Mar´ın, Sci. Rep. 3 (2013). [8] A. Lancichinetti, S. Fortunato, and F. Radicchi, Physical [19] B. Gaume, K. Duvignau, L. Pr´evot, and Y. Desalle, in Proceedings of the workshop on Cognitive Aspects of the Lexicon (Association for Computational Linguistics, 2008) pp. 86 -- 93. [20] M. Newman, Physical review E 74, 036104 (2006). [21] G. Csardi and T. Nepusz, InterJournal Complex Sys- tems, 1695 (2006). [22] A. Clauset, M. Newman, and C. Moore, Physical review Review E 78, 046110 (2008). E 70, 066111 (2004). [9] A. Lancichinetti, S. Fortunato, and J. Kert´esz, New [23] P. Pons and M. Latapy, Computer and Information Journal of Physics 11, 033015 (2009). Sciences-ISCIS 2005 , 284 (2005). [10] G. K. Orman, V. Labatut, and H. Cherifi, Journal of Statistical Mechanics: Theory and Experiment 2012, P08001 (2012). [11] V. Labatut, arXiv preprint arXiv:1303.5441 (2013). [12] W. Zachary, Journal of anthropological research , 452 (1977). [13] D. Lusseau, Proceedings of the Royal Society of London. Series B: Biological Sciences 270, S186 (2003). [14] J. Leskovec, K. Lang, and M. Mahoney, in Proceedings of the 19th international conference on World wide web (ACM, 2010) pp. 631 -- 640. [15] R. Cazabet, M. Leguistin, and F. Amblard, in Proceed- ings of the 4th International Workshop on Web Intelli- gence & Communities (ACM, 2012) pp. 1 -- 6. [24] M. Rosvall and C. T. Bergstrom, PloS one 6, e18209 (2011). [25] V. Blondel, J. Guillaume, R. Lambiotte, and E. Lefeb- vre, Journal of Statistical Mechanics: Theory and Exper- iment 2008, P10008 (2008). [26] T. Aynaud and J. Guillaume, in Modeling and Optimiza- tion in Mobile, Ad Hoc and Wireless Networks (WiOpt), 2010 Proceedings of the 8th International Symposium on (IEEE, 2010) pp. 513 -- 519. [27] V. Nicosia, G. Mangioni, V. Carchiolo, and M. Mal- geri, Journal of Statistical Mechanics: Theory and Ex- periment 2009, P03024 (2009).
1712.02370
1
1712
2017-12-06T19:03:07
Ensemble-Based Discovery of Disjoint, Overlapping and Fuzzy Community Structures in Networks
[ "cs.SI", "physics.soc-ph" ]
Though much work has been done on ensemble clustering in data mining, the application of ensemble methods to community detection in networks is in its infancy. In this paper, we propose two ensemble methods: ENDISCO and MEDOC. ENDISCO performs disjoint community detection. In contrast, MEDOC performs disjoint, overlapping, and fuzzy community detection and represents the first ever ensemble method for fuzzy and overlapping community detection. We run extensive experiments with both algorithms against both synthetic and several real-world datasets for which community structures are known. We show that ENDISCO and MEDOC both beat the best-known existing standalone community detection algorithms (though we emphasize that they leverage them). In the case of disjoint community detection, we show that both ENDISCO and MEDOC beat an existing ensemble community detection algorithm both in terms of multiple accuracy measures and run-time. We further show that our ensemble algorithms can help explore core-periphery structure of network communities, identify stable communities in dynamic networks and help solve the "degeneracy of solutions" problem, generating robust results.
cs.SI
cs
Ensemble-Based Discovery of Disjoint, Overlapping and Fuzzy Community Structures in Networks Tanmoy Chakraborty, Noseong Park Indraprastha Institute of Information Technology Delhi (IIIT-D), India University of North Carolina, Charlotte, USA Abstract Though much work has been done on ensemble clustering in data mining, the application of ensemble methods to community detection in networks is in its infancy. In this paper, we propose two ensemble methods: EnDisCo and MeDOC++. EnDisCo performs disjoint community detection. In con- trast, MeDOC++ performs disjoint, overlapping, and fuzzy community detec- tion and represents the first ever ensemble method for fuzzy and overlapping community detection. We run extensive experiments with both algorithms against both synthetic and several real-world datasets for which community structures are known. We show that EnDisCo and MeDOC++ both beat the best-known existing standalone community detection algorithms (though we emphasize that they leverage them). In the case of disjoint community de- tection, we show that both EnDisCo and MeDOC++ beat an existing ensemble community detection algorithm both in terms of multiple accuracy measures and run-time. We further show that our ensemble algorithms can help ex- plore core-periphery structure of network communities, identify stable com- munities in dynamic networks and help solve the "degeneracy of solutions" problem, generating robust results. Keywords: Ensemble approach, Community detection, Core-periphery organization, Stable communities 1. Introduction Though most human beings recognize a community of people when they see one, coming up with a formal mathematical definition of a community has proved challenging, leading to a plethora of diverse technical definitions Preprint submitted to Journal Name December 8, 2017 which capture the intuitive human understanding of a community with dif- ferent degrees of accuracy [1]. Because of this, different definitions of a com- munity use different objective functions (such as modularity [2], significance [3], permanence [4, 5, 6]), whose optimization leads to the detection of the underlying community structure. We ask ourselves the question: can we come up with a computational model of known communities in a network that accurately approximates real- world communities in the network by leveraging the best known existing net- work community detection algorithms and their associated objective func- tions? We are not the first to examine this question - ensemble methods have already been pioneered in network community detection by [7, 8], building on past work on clustering (in non-network settings) in data mining [9]. Apart from these factors, many other factors suggest that an ensemble- based approach may lead to significantly improved accuracy: • Dependence on vertex ordering: Existing community finding al- gorithms are highly dependent on vertex-ordering [10, 11]. If we let an algorithm start from different seed vertices in different iterations for a particular network, it might produce completely different community structures. Each structure can be viewed as a different view of what communities might exist. • Degeneracy of solution: Existing community finding algorithms suf- fer from the "degeneracy of solutions" problem because they admit an exponential number of distinct high-scoring solutions and typically lack a clear global maximum. Each such solution represents a possible view of the underlying community structure and there is no reason to prefer on over another. • Lack of ground-truth communities: Most real-world networks do not have (partial) ground-truth community structure to validate pre- dicted communities. Therefore, it is extremely challenging to do any cross-validation to tune the input parameters of an algorithm. In this paper, we extend our previous study [12] where we suggested how to combine multiple solutions to generate ensemble community detec- tion algorithms. However, it was unclear how one can select base solutions. Moreover, there was no single algorithm which can be able to detect three types of communities – disjoint, overlapping and fuzzy. In this paper, we 2 present a comprehensive experiment to show the Superiority of two of our proposed algorithms – EnDisCo, and MeDOC++, along with our previous find- ings [12]. In particular, the summary of the contributions presented in this paper is as follows: 1. We propose an ensemble-based algorithm called EnDisCo that identifies disjoint communities. EnDisCo is built on the idea that the larger the number of algorithms that place two vertices in the same community, the more likely it is that they really do belong to the same community. We represent each vertex in a feature space and capture the pair-wise distances between vertices. This in turn generates a latent network, capturing the hidden similarities among vertices. A re-clustering al- gorithm is then used to cluster the vertices in the latent network to produce the final community structure (Section 3). 2. We propose MeDOC++, a meta-clustering based algorithm that to the best of our knowledge is the first ensemble-based generalized commu- nity detection algorithm to detect disjoint, overlapping and fuzzy com- munities in a network. The idea behind this algorithm is to generate meta communities from the "base communities" (i.e. communities gen- erated by existing community detection algorithms) by grouping redun- dant solutions together. We propose a vertex-to-community association function that provides an accurate estimate of the community member- ship of different vertices in a network. This association function further allows us to detect overlapping and fuzzy community structures from the network (Section 4). 3. We conduct an experimental analysis using both synthetic and real- world networks whose ground-truth community structure is known. Ex- perimental results are shown separately for disjoint (Section 5), overlap- ping (Section 6) and fuzzy (Section 7) community detection. We show that our ensemble-based algorithms (particularly MeDOC++) outper- form all the state-of-the-art baseline algorithms with significant margin including the best known and best performing "consensus clustering" algorithm for disjoint community detection [8]. We also present a de- tailed explanation of how to choose the parameters of the ensemble algorithms. 4. We provide four strategies to choose a subset of "base" community detection algorithms in order to obtain highly accurate communities. These strategies are based on two fundamental quantities – quality and 3 diversity. We show that a trade-off of these two quantities is required to select the best subset of base solutions (Section 8). 5. MeDOC++ further allows us to explore the core-periphery structure of communities in a network. We observe that vertices with more associa- tion within a community form the core unit of the community, whereas peripheral vertices are loosely associated with the community. Fur- thermore, we show that one can use MeDOC++ to detect communities in a dynamic time-varying network that are stable, i.e., remain almost invariant over time (Section 9). 6. Finally we show that both EnDisCo and MeDOC++ significantly reduce the problem of "degeneracy of solutions" in community detection (Sec- tion 10) and are much faster than consensus clustering [8], a recently proposed ensemble-based disjoint community finding algorithm (Sec- tion 11). In this paper, the major additions of new contributions with our exist- ing work [12] are as follows: (i) We present MeDOC++, the first ensemble based algorithm that can detect disjoint, overlapping and fuzzy community structures (Section 4). (ii) We present results of detecting fuzzy community structures from synthetic and real-world networks (Section 7). To the best of our knowledge, this is the first time where the fuzzy community detection algorithm is verified against real-world ground-truth. (iii) We present four strategies to select a subset of base solutions which produce near-optimal results (Section 8). (iv) We present two new implications of MeDOC++ algo- rithm – (a) it can explore the core-periphery structure of communities in a network, (b) it can detect stable communities in dynamic networks (Section 9). (v) We present detailed analysis to show how our proposed algorithms reduce the effect of "degeneracy of solutions" compared to other baseline algorithms (Section 10). Throughout the paper, we use the term "community structure" to indi- cate the result returned by a community detection algorithm. A community structure therefore consists of a set of "communities" and each community consists of a set of vertices. 2. Related Work In this section, we present the literature related to the community detec- tion in three subparts. First, we describe past efforts on disjoint community 4 detection. Second, we discuss fuzzy and overlapping community detection. Finally, we present related work on ensemble-based community detection. Due to the abundance of literature on community detection, we restrict our discussion to best known and/or most recent works. Extensive survey articles on community detection are available in [1], [13] and [14]. 2.1. Disjoint Community Detection Past efforts devoted to community detection mostly assume that nodes are densely connected within a community and sparsely connected across communities. Such efforts include modularity optimization [15, 16, 17, 18, 2], spectral graph-partitioning [19, 20], clique percolation [21, 22], local expan- sion [23, 24], random-walk based approaches [25, 26], information theoretic approaches [27, 28], diffusion-based approaches [29], significance-based ap- proaches [30] and label propagation [29, 31, 32]. Most of these efforts detect communities in static networks. On the other hand, a large number of al- gorithms were proposed to detect communities in dynamically evolving net- works (i.e., Internet, Online Social Networks), such as LabelRankT [33], Es- trangement [34] and intrinsically dynamic community detection algorithm [35]. Several pre-processing techniques [36, 37] have been developed to improve the quality of the solutions generated by these algorithm. These methods gener- ate preliminary community structure on a set of selected vertices and then modify the structure over successive steps to cover all the vertices. Recently, [11] showed the effect of vertex ordering on the performance of the community detection algorithms. 2.2. Fuzzy and Overlapping Community Detection Another set of community detection algorithms allow a vertex to be a part of multiple communities. "CFinder" [22] was the first method of this kind which was based on clique-percolation technique. However, since more real- world networks are sparse in nature, CFinder generally produces low quality output [38]. The idea of partitioning links instead of vertices to discover community structure has also been explored [39]. Some algorithms are based on local expansion and optimization such as LFM [24], OSLOM [30], EAGLE [40], MOSES [41] and GCE [42]. [43, 44] proposed fuzzy community detection technique. BIGCLAM [45] uses Nonnegative Matrix Factorization (NMF) framework for fuzzy/overlapping community detection. Zhang et al. used NMF to detect overlapping communities given the feature vector of vertices and known number of communities [46]. 5 There is another type of algorithms which exploit local expansion and optimization to detect overlapping communities. For instance, "RankRe- moval" algorithm [47] uses a local density function. LFM [48] and MONC [49] maximize a fitness function over successive iterations. OSLOM [30] mea- sures the statistical significance of a cluster w.r.t a global null model during community expansion. [50] proposed a combination of "belongingness" and "modified modularity" for local expansion. EAGLE [40] and GCE [42] use an agglomerative framework to detection overlapping communities. COCD [51] first identifies cores after which the remaining vertices are attached to the cores with which they have the largest connections. [52] modeled overlapping community detection as a nonlinear constrained optimization problem and solved by simulated annealing methods. [53, 54, 55, 56] used mixer model to solve this problem. [57] used affinity propagation clustering methods for overlapping community detection. [58] proposed a seed set expansion approach for community detection. The label propagation algorithm has been extended to overlapping com- munity detection. COPRA [59] updates "belonging coefficient" of a vertex by averaging the coefficient from all its neighbors at each time step. SLPA [32, 31] propagates labels across vertices based on the pairwise interaction rules. [60] proposed a game-theoretic framework in which a community is associated with a Nash local equilibrium. Beside these, CONGA [61] uses GN algorithm [62] to split a vertex into multiple copies. [63] proposed an iterative process that reinforces the net- work topology and proximity that is interpreted as the probability of a pair of vertices belonging to the same community. [64] proposed an approach fo- cusing on centrality-based influence functions. [65] proposed fuzzy clustering based disjoint community detection technique. 2.3. Community Detection using Ensemble Approach There has been a plethora of research in traditional data mining (not in- volving networks) to cluster data points using an ensemble approach (see [9] for a detailed review). These approaches can be classified into two categories [9]: object co-occurrence based approaches and median partitioning based approaches. However, when it comes to the case of clustering vertices in networks, there are very few such attempts. [7] proposed an instance-based ensemble clustering method for network data by fusing different community structures. [29] addressed the advantages of combining multiple community 6 structures. CGGC [66] presents a modularity maximization based ensem- ble technique. YASCA is another ensemble approach that can detect ego- centered communities [67, 68], and identified the importance of the quality and diversity of base outputs [69]. Recently, [8] proposed "consensus clustering" which leverages a consen- sus matrix for disjoint graph clustering. It detects consensus clustering by reweighting the edges based on how many times the pair of vertices are al- located to the same community by different identification methods. This has been proved to be a stable method, outperforming previous approaches for disjoint community detection. However, we differ from them w.r.t. four different points as follows: 1. Past work measures the number of times two vertices are assigned to the same community, thus ignoring the global similarity of vertices; whereas we aim at capturing the global aspect by representing the network into a feature space or grouping the redundant base communities into a meta community. 2. They either take multiple algorithms or run a particular algorithm mul- tiple times for generating inputs to an ensemble algorithm, whereas we consider both of them. 3. They run algorithms multiple times to generate consensus matrix in each iteration, and keep on repeating the same steps until the matrix converges to a block diagonal matrix which leads to a huge computa- tional cost; whereas we run base algorithms multiple time only in the first step and leverage the base solutions in later steps which decreases the overall runtime. This leads to significant performance gains. 4. We are the first to show how aggregating multiple disjoint base commu- nities can lead to discover disjoint, overlapping and fuzzy community structures simultaneously. However, we consider consensus clustering as one of the state-of-the-art techniques for disjoint community detection and compare it with our algo- rithms. For overlapping and fuzzy community detection, we present the first ever "ensemble based" algorithm in the literature. 3. EnDisCo: Ensemble-based Disjoint Community Detection In this section, we present EnDisCo (Ensemble-based Disjoint Community Detection), an ensemble based algorithm to generate disjoint communities in 7 Algorithm 1: EnDisCo: Ensemble-based Disjoint Community Detec- tion Data: Graph G(V, E); Base algorithms AL = {Alm}M K: Number of iterations; INV(., .): Involvement function; SIM(., .): Similarity function between two vectors; RAlgo: Algorithm for re-clustering Result: Disjoint community structure DC m=1; 1 Γ = φ // Generating base partitions 2 for each algorithm Alm ∈ AL do // Set of all base community structures 3 4 Run Alm on G for K different vertex orderings and obtain K community structures, denoted by the set Γm; each community structure Ck m = {C1k Ck Γ = Γ ∪ Γm; m ∈ Γm is of different size and indicated by m }; m , ..., Cak 5 for each v in V do 6 // Feature vector of v // Max distance of v to any community // Total no of communities F (v) = φ; Dv = 0; Clu = 0; // Constructing ensemble matrix for each Γm ∈ Γ do for each Ck m ∈ Γm do for each C ∈ Ck m do v = 1 − INV(v, C); Compute dC F (v) = F (v) ∪ dC v ; v ≥ Dv then if dC Dv = dC v ; Clu = Clu + 1; P (v) = φ; for each Fi(v) ∈ F (v) do // Posterior probability of v in Ck i Compute P (Civ) = ; P (v) = P (v) ∪ P (Civ); Clu·Dv+Clu−(cid:80)Clu Dv−Fi(v)+1 k=1 Fk(v) 7 8 9 10 11 12 13 14 15 16 17 18 19 20 21 Build an ensemble matrix MV ×V , where ∀u, v ∈ V ; M(u, v)=SIM(P (u), P (v)); // Re-clustering the vertices from M 22 Run RAlgo for re-clustering vertices from M and discover a disjoint community structure DC; 8 23 return DC Notation G(V, E) AL K Ck m Γm Γ F (v) Dv Clu INV(v, c) P (Civ) P (v) SIM(u, v) M Table 1: Few important notations used in this paper. Description m , ..., C ak m}K m=1, set of all M K base disjoint community structures k=1, set of base disjoint community structures discovered by base algorithm m=1}, set of M base disjoint community detection algorithms m }, base community structure discovered by a base disjoint algorithm An undirected network with sets of vertices V and edges E {AlM Number of iterations (number of vertex orderings) {C 1k Alm on kth vertex ordering {Ck Alm on K different vertex orderings ΓM Feature vector of a vertex v Maximum distance of v to any community ¯aM K, approximate total number of communities in Γ (¯a is the average size of a base community structure) Involvement function of v in community C Posterior probability of v being part of a community Ci probability distribution of v being part of different communities Similarity function between two vertices Ensemble matrix, where M(u, v) indicates the similarity of vertices u and v W (Ci, Cj) Matching function between two communities F(v, C) CGP A GP}L l=1, meta-communities obtained from P-partite graph GP A function measuring the association between vertex v and community C {C l Association matrix, where A(v, l) indicates the association of v in meta-community l Normalized association matrix, where A(v, l) = A thresholds needed to detect the overlapping community structure in MeDOC++ Final disjoint community structure Final overlapping community structure Final fuzzy community structure A(v,l) l(cid:48)∈L A(v,l(cid:48)) (cid:80) A τ OC OC FC networks. EnDisCo generates a strong start by producing different commu- nity structures using an ensemble of base community detection algorithms. Then an involvement function is used to measure the extent to which a vertex is involved with a specific community detected by a base algorithm. This in turn sets the posterior probability that a vertex belongs to any one of many different communities. This step transforms a network into a feature space. Following this, an ensemble matrix that measures the pair-wise similarity of vertices in the feature space is constructed, and this serves as a latent adja- cency matrix in the next step. Finally, we apply a re-clustering algorithm on the ensemble matrix and discover the final disjoint community structure. 3.1. Algorithmic Description EnDisCo follows three fundamental steps (a pseudo-code is shown in Algorithm 1, a toy example of the work-flow is presented in Figure 1, and important notations are shown in Table 1): 9 (i) Generating base partitions. Given a network G = (V, E) and a set AL = {Alm}M m=1 of M different base community detection algorithms, EnDisCo runs each algorithm Alm on K different vertex orderings (randomly selected) of G. This generates a set of K different community structures de- m } m ,··· , C ak noted Γm = {Ck constitutes a specific partitioning of vertices in G, and each Ck m might be of different size (Step 3). k=1, where each community structure Ck m = {C 1k m}K (ii) Constructing ensemble matrix. Given a Γm, we then compute the extent of v's involvement in each community C in Ck m via an "involvement" function INV(v, C) (Step 12). Possible definitions of INV are given in Section 3.2. For each vertex v, we construct a feature vector F (v) whose elements indicate the distance of v (measured by 1 − INV) from each community obtained from different runs of the base algorithms (Step 13). The size of F (v) is the number of communities Clu in Γ (approx. ¯aM K, where ¯a is the average size of a base community structure). Let Dv be the largest distance of v from any community in the sets in Γ (i.e., Dv = maxi Fi(v) in Step 15). We define the conditional probability of v belonging to community Ci (Step 19) as: k 1 factor in the denominator ensures that (cid:80)Clu The numerator ensures that the greater the distance Fi(v) of v from com- munity Ci, the less likely v is to be in community Ci. The normalization k=1 P (Civ) = 1. We further ob- serve that ∀v ∈ V and ∀i, P (Civ) > 0. Add-one smoothing in the numerator allows a non-zero probability to be assigned to all Cis, especially for Ck such Fk(v). In this case P (Civ) is assigned its maximum value that k = argmax P (Ckv) = . The larger the deviation of Fk(v) from Dv, the more the increase of P (Civ), the corresponding community Ci becomes more likely for v. Clu·Dv+Clu−(cid:80)Clu The set of posterior probabilities of v is: P (v) = {P (Ckv)}Clu k=1 (Step 20), which in turn transforms a vertex into a point in a multi-dimensional feature space. Finally, we construct an ensemble matrix M whose entry M (u, v) is the similarity (obtained from a function SIM whose possible definitions are given in Section 3.2) between the feature vectors of u and v (Step 21). The ensemble matrix ensures that the more communities a pair of vertices share k=1 Fk(v) P (Civ) = Clu · Dv + Clu −(cid:80)Clu Dv − Fi(v) + 1 k=1 Fk(v) (1) 10 Figure 1: A toy example depicting the work-flow of EnDisCo algorithm. The broken lines indicate the community boundaries. Assume that the base algorithms produce three different community structures in Step 2, and we use Restricted Closeness Centrality (RCC) and Cosine Similarity (COS) as involvement and similarity functions respectively. The definitions of COS and RCC are described in Section 3.2. the more likely they are connected in the network [45]. (iii) Discovering final community structure. In Step 22 we use a com- munity detection algorithm RAlgo to re-cluster the vertices from M and discover the final disjoint community structure (Step 22). 3.2. Parameter Selection We now describe different parameters of EnDisCo: • Involvement Function (INV): We use two functions to measure the involvement of a vertex v in a community C: (i) Restricted Close- ness Centrality (RCC): This is the inverse of the average shortest- path distance from the vertex v to the vertices in community C, i.e., RCC(v, C) = u∈C dist(v,u); (ii) Inverse Distance from Centroid (IDC): we first identify the vertex with highest closeness centrality (w.r.t. the induced subgraph of C) in community C, mark it as the centroid of C (denoted by uc), and then measure the involvement of v as the inverse of the shortest-path distance between v and uc, i.e., IDC(v, C) = dist(v,uc). (cid:80) 1 C 11 Example 3.1. In Figure 1, the RCC of vertex D for community C12 is measured as follows. The shortest-path distances of D from E, F 1+1+2 = 3 and G are 1, 1 and 2 respectively. Then RCC(D, C12) = 3 4. On the other hand, the centroid of community C12 is vertex G and the distance between D and G is 2. Therefore, IDC(D, C12) = 1 2. • Similarity Function (SIM): We consider cosine similarity (COS) and Chebyshev similarity (CHE) (Chebyshev similarity is defined as (1 − CHEd) where CHEd is the Chebyshev distance) to measure the similarity between two vectors. • Algorithm for Re-clustering (RAlgo): we consider each base com- munity detection algorithm as a candidate to re-cluster vertices from the ensemble matrix. The idea is to show that existing community detection algorithms can perform even better when they consider the ensemble matrix of network G as opposed to the adjacency matrix of G. However, one can use any community detection algorithm in this step to detect the community structure. We will show the effect of different algorithms used in this step in Section 5.4.2. • Number of Iterations (K): Instead of fixing a hard value, we set K to be dependent on the number of vertices V in the network. We vary K from 0.01 to 0.50 (with step 0.05) of V and confirm that for most of the networks, the accuracy of the algorithm converges at K = 0.2V (Figures 3(c) and 3(f)), and therefore we set K = 0.2V in our experiments. 3.3. Complexity Analysis Suppose N = V is the number of vertices in the network, M is the number of base algorithms and K is the number of vertex orderings. Further suppose ¯a is the average size of the community structure. Then the loop in Step 5 of Algorithm 1 would iterate ¯aN M K times (where M, K (cid:28) N ). The construction of the ensemble matrix in Step 21 would take O(N 2). Graph partitioning is NP-hard even to find a solution with guaranteed approxi- mation bounds - however, heuristics such as the famous Kernighan-Lin algorithm take O(N 2 · log(N )) time. 12 Algorithm 2: MeDOC++: A Meta Clustering based Disjoint, Overlapping and Fuzzy Community Detection Data: Graph G(V, E); Base algorithms AL = {Alm}M K: Number of iterations; W (., .): Matching between pair-wise communities; RAlgo: Algorithm for re-clustering; F(., .): vertex-to-community association; τ : threshold for overlapping community detection Result: Disjoint (DC), overlapping (OC) and fuzzy (FC) community m=1; structures // Constructing multipartite network 1 for Alm in AL do 2 Run Alm on G for K different vertex orderings and obtain K community structures, denoted by the set Γm = {Ck k=1; each m ∈ Γm may be of different size and is community structure Ck m = {C 1k denoted by Ck i }; m , ..., C ak m}K m , C jk(cid:48) n ); 3 Construct a P -partite graph GP (where P = M.K) consisting of M.K partitions, each corresponding to each community structure obtained in Step 2: vertices in partition mk are communities in Ck m and edges are drawn between two pair-wise vertices (communities) C ik m and C jk n with the edge weight W (C ik // Re-clustering the multipartite network meta-community structure, CGP = {C l // Constructing an association matrix 5 Construct an association matrix AV ×L, where A(v, l) = F(v, C l GP ), indicating the association of vertex v to a meta-community C l GP ; // Discovering final community structure 4 Run RAlgo to re-cluster vertices in GP and discover a 6 Each row in A indicates the memberships of the corresponding vertex GP}L l=1; in L meta-communities; 7 To get DC, we assign a vertex v to community C∗ = argmax 8 To get OC, we assign a vertex v to a set of communities C∗ C A(v, C); v so that ∀C ∈ C∗ v : A(v, C) ≥ τ ; 9 To get FC, we first normalize each entry in A by the sum of entries in the corresponding row and obtain a normalized association matrix A, i.e., A(v, l) = with the membership probability of A(v, C); A(v,l(cid:48)); and assign a vertex v to a community C A(v,l) l(cid:48)∈L (cid:80) 10 return DC, OC, FC 13 Figure 2: A toy example depicting the work-flow of MeDOC++ algorithm. The broken lines indicate the community boundaries. Assume that the base algorithms produce three different community structures in Step 2, and we use Jaccard Similarity (JC) and simple association (F) as matching and association functions respectively. The definitions of JC and F are described in Section 4.2. The threshold τ is chosen as 1 6 . 4. MEDOC++: Meta-clustering Approach MeDOC++ (Meta Clustering based Disjoint, Overlapping and Fuzzy Community Detection) starts by executing all base community detection algorithms, each with different vertex orderings, to generate a set of com- munity structures. It then creates a multipartite network. After this, an- other community detection algorithm is used to partition the multipartite network. Finally, a vertex-to-community association function is used to de- termine the strength of membership of a vertex in a community. Unlike EnDisCo, MeDOC++ can yield disjoint, overlapping and fuzzy community structures from the network. 4.1. Algorithmic Description MeDOC++ has the following four basic steps (pseudo-code is in Algorithm 2, a toy example of the work-flow of MeDOC++ presented in Figure 2, and important notations are shown in Table 1): (i) Constructing multipartite network. MeDOC++ takes a set AL = {Alm}M m=1 of M base community detection algorithms as input and runs each Alm on K different vertex orderings of G. For each ordering k, Alm 14 m , ..., C ak m = {C 1k m}K m network (aka meta-network) GP as follows: vertices are members of(cid:83) i } of varying size (Step produces a community structure Ck 2). After running on K vertex orderings, each algorithm Alm produces K different community structures Γm = {Ck k=1. Therefore at the end of Step 2, we obtain K community structures each from M algorithms (essentially, we have P = M.K community structures). We now construct a P -partite Ck m, i.e., a community present in a base community structure (obtained from any of the base algorithms in AL and any vertex ordering) is a vertex of GP . We draw an edge from a community C ik n and associate a weight W (C ik n ) (Step 3). Possible definitions of W will be given later in Section 4.2. Since each Ck m is disjoint, the vertices in each partition are never connected. m to a community C jk(cid:48) m , C jk(cid:48) (ii) Re-clustering the multipartite network. Here we run any stan- dard community detection algorithm RAlgo on the multipartite network GP and obtain a community structure containing (say) L communities CGP = {C l l=1. Note that in this step, we cluster the communities obtained ear- lier in Step 2; therefore each such community C l GP obtained here is called a "meta-community" (or community of communities) (Step 4). GP}L (iii) Constructing an association matrix. We determine the associa- tion between a vertex v and a meta-community C l GP by using a function F and construct an association matrix A of size V × L, where each entry GP ) (Step 5). Possible definitions of F will be given later in A(v, l) = F(v, C l Section 4.2. (iv) Discovering final community structure. Final vertex-to-community assignment is performed by processing A. The entries in each row of A denote membership probabilities of the corresponding vertex in L commu- nities. For disjoint community assignment, we label each vertex v by the community l in which v possesses the most probable membership in A, i.e., l∗ = argmax A(v, l). Tie-breaking is handled by assigning the vertex to the community to which most of its direct neighbors belong. Note that not every meta-community can be guaranteed to contain at least one vertex. Thus, we cannot guarantee that there will be L communities in the final community structure. For discovering overlapping community structure, we assign a ver- tex v to those communities for which the membership probability exceeds a l 15 threshold τ . Possible ways to specify this threshold will be specified later in Section 4.2. For fuzzy community detection, we first normalize each entry of A(v, l) by the sum of entries in the corresponding row so that the membership probability of each vertex in different communities sums up to 1. This in A(v, l). Accordingly we assign each turn returns a new association matrix vertex v to a community C with the membership probability of A(v, C) (see Step 9). 4.2. Parameter Selection Here we describe the parameters used in MeDOC++ algorithm: • Matching Function (W ): Given two communities Ci and Cj, we Ci∩Cj Ci∪Cj measure their matching/similarity via Jaccard Coefficient (JC)= and average precision (AP) = 1 2( Ci∩Cj Ci + Ci∩Cj Cj ). Example 4.1. In Figure 2, the Jaccard Coefficient between C11 and C21 is JC(C11, C21) = 3 4. The average precision between them is AP (C11, C21) = 1 4 + 3 3) = 7 8. 2( 3 (cid:80)γ • Association Function (F): Given a meta-community C consisting of (say,) γ communities, the association of v with C can be calculated as F(v, C) = , where δ returns 1 if v is a part of C l, 0 otherwise. Alternatively, a weighted association measure may assign a score to v w.r.t. C based on the co-occurrence of the other community members with v, i.e., Fw(v, C) = l=1 δ(v,Cl) Clδ(v,Cl) Cl∈C γ (cid:12)(cid:12) (cid:84) (cid:12)(cid:12) (cid:83) Cl∈C (cid:12)(cid:12) (cid:12)(cid:12). Clδ(v,Cl) Example 4.2. In Figure 2, the simple association between vertex A and meta community M C1 is F(A, M C1) = 3 3 = 1 because A is present in C11, C21 and C31 communities which are parts of M C1. On the other hand, the weighted association between A and M C1 is Fw(A, M C1) = {A,B,C,D}∩{A,B,C}∩{A,B,C} {A,B,C,D}∪{A,B,C}∪{A,B,C} = 3 4. • Threshold (τ ): We choose the threshold τ automatically as follows. We first assign each vertex to its most probable community – this pro- duces a disjoint community structure. Each vertex vi is represented by a feature vector F (vi) which is the entire i'th row of the association 16 (cid:80) matrix A. We then measure the average similarity of vertices in C as follows: AS(C) = , where EC is the set of edges completely internal to C, Euv is an edge (u, v), and COS is cosine similarity. The probability that two vertices are connected in C is then defined as: (u,v)u,v∈C∧Euv∈EC EC COS(F (u),F (v)) (2) For a vertex v, if P (C ∪ {v}) ≥ P (C), we further assign v to C, in addition to its current community. 1 + e[AS(C)]2 P (C) = e[AS(C)]2 Example 4.3. In Figure 2, let us measure the threshold for community DC1 that we obtain in the final step after discovering the disjoint community structure. From the association matrix A in the figure, F (A) = {1, 0}, F (B) = {1, 0} and F (C) = {1, 0}. So the average similarity of vertices in DC1 in terms of cosine similarity is AS(DC1) = 1. Then the probability of two vertices in DC1 being connected is P (DC1) = 0.88. If we add D to DC1, the new probability P (DC1 ∪ D) = 0.80 and P (DC1 ∪ D) < P (DC1). Therefore, D is not assigned to DC1. It is worth noting that the selection of a threshold depends upon which community we start with. For instance, in Figure 2, if we start from community DC2 and calculate the increase in probability after assign- ing B to it, it would treat this assignment as a valid assignment. If we continue assigning the other vertices, the entire network would get assigned to a single community. To avoid this situation, we start from that community for which the membership probability P (C) is highest among all and keep assigning other vertices to it. In Figure 2, we start from DC1. Once the members in a given community are finalized, we will not perturb their community membership further. This in turn also reduces runtime. We compare our threshold selection method with the following method: each vertex is assigned to its top n% high probable communities (we set n to 5% or 10%). Our experiments show that MeDOC++ delivers excellent performance with our threshold selection method (see Figures 4(g) and 4(i)). Other input parameters RAlgo and K remain same as discussed in Section 3.2. 17 Table 2: Properties of the real-world networks with disjoint community structure. N : number of vertices, E: number of edges, C: number of communities, ρ: average edge- density per community, S: average size of a community. E C 3 12 21 24 Network University Football Railway Coauthorship N 81 115 301 103,677 817 613 1,224 352,183 ρ 0.54 0.64 0.24 0.14 S 27 9.66 13.26 3762.58 4.3. Complexity Analysis The most expensive step of MeDOC++ is to construct the multipartite network in Step 3. If M is the number of base algorithms, K is the number of vertex orderings and ¯a is the average size of a base community structure, the worst case scenario occurs when each vertex in one partition is connected to each vertex in other partitions - if this happens, the total number of edges is O(¯a2M 2K 2). However, in practice the network is extremely sparse and leads to O(¯aM K) edges (because in sparse graphs O(V ) ∼ O(E)). Further, constructing the association matrix would take O(N L) iterations (where L (cid:28) N ). 5. Experiments: Results of Disjoint Community Detection In this section, we evaluate EnDisCo and MeDOC++ for disjoint community detection. We start by explaining the datasets used in this experiment, followed by the baseline algorithms taken to compare against our algorithms, and the evaluation metrics used to compare the detected communities with the ground-truth. Then in the experimental results we will show how we select the parameters and the comparative analysis. 5.1. Datasets We use both synthetic networks with community structures embedded, and real-world networks of different sizes with known ground-truth commu- nity structure. 5.1.1. Synthetic Networks We use the LFR benchmark model [70] to generate synthetic networks with ground-truth community structure by varying the number of vertices n, mixing parameter µ (the ratio of inter- and intra-community edges), average 18 degree ¯k, maximum degree kmax, minimum (maximum) community size cmin (cmax), average percentage On of overlapping vertices and the average number Om of communities to which a vertex belongs. The parameter µ controls the quality of the community structure – the more the value of µ, the more the inter-community edges and the less the quality of the community structure. We vary this parameter in order to generate different network and community structures. We also vary Om and On to obtain communities in different extent of overlapping (see Section 6). Unless otherwise stated, we generate networks with the same parameter configuration used in [4, 67] for disjoint community structure: n = 10000, ¯k = 50, kmax = 150, µ = 0.3, On = 0, Om = 1, cmax = 100, cmin = 20. Note that for each parameter configuration, we generate 50 LFR networks, and the values in all the experiments are reported by averaging the results. 5.1.2. Real-world Networks We also use the following four real-world networks mentioned in Table 2 for experiments: Football network: This network constructed from [16] contains the network of American football games between Division IA colleges during the regular season of Fall 2000. The vertices in the network represent teams (identified by their college names) and edges represent regular-season games between the two teams they connect. The teams are divided into conferences (indicating communities) containing around 8-12 teams each. Railway network: This network proposed by [4] consists of vertices rep- resenting railway stations in India, where two stations si and sj are connected by an edge if there exists at least one train-route such that both si and sj are scheduled halts on that route. Here the communities are states/provinces of India since the number of trains within each state is much higher than the trains in-between two states. University network: This network generated by [52] is a friendship network of a faculty of a UK university, consisting of 81 vertices (individuals) and 817 connections. The school affiliation of each individual is stored as a vertex attribute. Schools act as communities in this network. Coauthorship network: This network suggested by Chakraborty et al. [4] is derived from the citation dataset [71]. Here each vertex represents an author. An undirected edge between authors is drawn if the two authors coauthor at least one paper. The communities are marked by the research fields since authors have a tendency to collaborate with other authors within 19 the same field. It may be possible that an author has worked on multiple fields, which causes the communities to overlap. We assign an author to that research community in which he/she has published the most papers. However, later in Section 7 for fuzzy community detection we will leverage this information to prepare the fuzzy ground-truth community structure. 5.2. Baseline Algorithms There exist numerous community detection algorithms which differ in the way they define community structure. Here we select the following set of algorithms as our baselines and categorize them according to the principle they use to identify communities as per [72]: (i) Modularity- based approaches: FastGreedy (FstGrdy) [18], Louvain (Louvain) [15] and CNM [16]; (ii) Vertex similarity-based approaches: WalkTrap (WalkTrap) [26]; (iii) Compression-based approaches: InfoMap (InfoMap) [28]; (iv) Diffusion-based approaches: Label Propagation (LabelPr) [29]; (v) En- semble approaches: The most recent ensemble-based disjoint community detection algorithm is Consensus Clustering (ConsCl) [8]. This algorithm starts by running a base algorithm multiple times and generates a consensus matrix, i.e., a matrix based on the co-occurrence of vertices in communities of the input partitions. The consensus matrix is further used as an input to the base algorithm adopted, leading to a new set of partitions, which gener- ate a new consensus matrix, until a unique partition is finally reached, which cannot be altered by further iterations. as base algorithms in AL in our ensemble approaches. Note that all these algorithms, except consensus clustering are also used 5.3. Evaluation Metrics Since the ground-truth community structure is available for each network, we use the following two standard metrics to compare the detected commu- nity structure with the ground-truth: Normalized Mutual Information (NMI) [73] and Adjusted Rand Index (ARI) [74]. The larger the value of NMI and ARI, the better the matching between two community structures. 5.4. Experimental Results We first run experiments to identify the best parameters for EnDisCo and MeDOC++ for disjoint community detection and then compare them with competing algorithms. 20 Figure 3: Dependencies of the performance of EnDisCo (left panel) and MeDOC++ (right panel) on different parameters. The quality of the ground-truth community is varied by changing µ from 0.1 to 0.8 (keeping the other LFR parameters default) and the perfor- mance is measured using NMI. In (c) and (f), we vary K and report the accuracy for three different LFR and Football networks (the results are similar for the other real networks and are not shown). The value corresponding to one parameter is reported by averaging the values for all possible combinations of the other parameters. The results are statistically significant (for multiple curves in (c) and (f), we report the range of p-values). 5.4.1. Dependency on the Parameters We consider the LFR networks and vary µ. Figure 3(a) shows that the accuracy of EnDisCo is similar for both the involvement functions, while Figure 3(b) shows that cosine similarity outperforms Chebyshev similarity. Figure 3(d) shows that Jaccard coefficient performs significantly better than average precision when MeDOC++ is considered, while Figure 3(e) shows that the weighted association function is superior to the other for µ < 0.6 and exhibits similar performance for µ ≥ 0.6. We further vary the number of iterations K to obtain communities with different vertex orderings – Figures 3(c) and 3(f) show that for the networks with strong community structure (such as LFR (µ = 0.1), Football), the accuracy levels off at K = 0.2V ; however with increasing µ leveling off occurs at larger values of K. Note that the patterns observed here for the LFR network are similar for other networks. Therefore unless otherwise stated, in the rest of the experiment we 21 µ0.10.20.30.40.50.60.70.8NMI0.60.70.80.9(a) Involvement Function RCCIDCµ0.10.20.30.40.50.60.70.80.60.70.80.9(b) Similarity Function COSCHEµ0.10.20.30.40.50.60.70.80.70.80.91(d) Matching Function JCAPµ0.10.20.30.40.50.60.70.80.70.80.91(e) Association Function FFwK0.10.20.30.40.50.60.81(c) No. of iterationsLFR (0.1)LFR (0.3)LFR (0.6)FootballK0.10.20.30.40.50.40.60.81(f) No of iterationsLFR (0.1)LFR (0.3)LFR (0.6)FootballEnDisCop=0.009p=0.008p=0.035MeDOC++p=0.003 show the results of our algorithms with the following parameter settings for disjoint community detection: EnDisCo: K = 0.2V , RCC, COS; MeDOC++: K = 0.2V , JC, Fw. 5.4.2. Impact of Base Community Detection Algorithms on EnDisCo and MeDOC++ In order to assess the impact of each base algorithm in our ensemble, we measure the accuracy of EnDisCo and MeDOC++ when that base algorithm is removed from the ensemble in isolation - Table 3 shows that for LFR and real-world networks InfoMap has the biggest impact on accuracy accord- ing to both the evaluation measures (NMI and ARI) for both EnDisCo and MeDOC++. We also observe that the overall accuracy of the ensemble algo- rithms decrease after removing each base algorithm. Therefore, irrespective of the quality of the base algorithms, we might need all of them to obtain high quality community structures as output. However, from this result it is not clear – (i) whether we need all the outputs obtained from K vertex orderings of a base algorithm, (ii) whether a certain combination of the base algorithms would produce the same accuracy as that obtained from using all the base algorithms. We will discuss more on these issues in Section 8. 5.4.3. Impact of Re-clustering Algorithms on EnDisCo and MeDOC++ As the final step in both EnDisCo and MeDOC++ is to run an algorithm for re-clustering, we also conduct experiments to identify the best re-clustering algorithm. Table 4 shows that for both LFR networks and real networks, InfoMap is the best re-clustering algorithm. 5.4.4. Comparative Evaluation Table 5 and Table 6 report the performance of our approaches on synthetic and real-world networks respectively using different algorithms in the final step of EnDisCo, MeDOC++ and ConsCl for synthetic networks. The num- bers denote relative performance improvement of EnDisCo, MeDOC++ and ConsCl with respect to a given algorithm when that algorithm is used in the final step. For instance, the last entry in the last row (7.82) means that for LFR (µ = 0.6) network, the accuracy of MeDOC++ (when LabelPr is used for re-clustering in its final step) averaged over NMI and ARI is 7.82% higher than that of the standalone LabelPr. The actual values are reported in Ta- ble 7. The point to take away from this table is that irrespective of which 22 Table 3: Impact of each base algorithm on the accuracy of EnDisCo and MeDOC++. The results are reported on default LFR and real networks with default parameter settings of the proposed algorithms (we use InfoMap as the final re-clustering algorithm). Each base algorithm is removed in isolation during the construction of ensemble matrix. (a) LFR Network Disjoint Overlapping MeDOC++ Ω EnDisCo MeDOC++ NMI ARI NMI ARI ONMI 0.85 0.83 0.82 0.82 0.80 0.84 0.84 0.87 0.84 0.85 0.83 0.81 0.85 0.86 0.90 0.88 0.86 0.87 0.82 0.81 0.87 0.84 0.83 0.81 0.82 0.80 0.83 0.83 0.89 0.88 0.86 0.85 0.81 0.88 0.87 (b) Real-world Network Football Senate Base Algorithm No. (1) All (2) (3) (4) (5) (6) (7) (1) − FstGrdy (1) − Louvain (1) − CNM (1) − InfoMap (1) − WalkTrap (1) − LabelPr Base Algorithm No. (1) All (2) (3) (4) (5) (6) (7) (1) − FstGrdy (1) − Louvain (1) − CNM (1) − InfoMap (1) − WalkTrap (1) − LabelPr 0.87 0.85 0.84 0.85 0.81 0.86 0.85 0.85 0.83 0.80 0.82 0.79 0.81 0.81 MeDOC++ Ω EnDisCo MeDOC++ NMI ARI NMI ARI ONMI 0.90 0.89 0.87 0.86 0.84 0.89 0.89 0.81 0.80 0.78 0.79 0.76 0.80 0.80 0.93 0.90 0.91 0.91 0.83 0.88 0.90 0.92 0.90 0.86 0.87 0.87 0.91 0.90 0.92 0.91 0.88 0.88 0.85 0.89 0.91 classical community detection algorithm we compare against, EnDisCo and MeDOC++ always improve the quality of communities found. Moreover, our proposed algorithms outperform ConsCl for all the networks. We further observe from the results of LFR networks that with the deterioration of the community structure (increase of µ), the improvement increases for all the re-clustering algorithms. This essentially indicates that ensemble based ap- proaches are even more useful if the underlying community structure is not well-separated. We further compare EnDisCo and MeDOC++ with the performance of com- peting algorithms on real-world networks. Table 6 presents the same patterns observed for synthetic networks. Once again, our proposed algorithms out- perform both ConsCl and the other standalone algorithms. For the Football network, our algorithms perform as well as other baseline algorithms, because the underlying community structure is very clear in the Football network [16]. Interestingly, our algorithms exhibit better performance for the Coauthorship network which has weaker community structure [4]. Both the results on synthetic and real-world networks lead to the conclu- 23 Table 4: Impact of each algorithm at the final stage of EnDisCo and MeDOC++ to re-cluster vertices. The results are reported on (a) default LFR network and (b) two real-world networks with the default parameter values of the proposed algorithms. Re-clustering Algorithm FstGrdy Louvain CNM InfoMap WalkTrap LabelPr Re-clustering Algorithm FstGrdy Louvain CNM InfoMap WalkTrap LabelPr (a) LFR Network Disjoint Overlapping MeDOC++ Ω EnDisCo MeDOC++ NMI ARI NMI ARI ONMI 0.79 0.82 0.83 0.85 0.75 0.77 0.80 0.84 0.81 0.89 0.78 0.79 0.83 0.86 0.86 0.90 0.82 0.80 0.80 0.83 0.83 0.87 0.77 0.78 0.81 0.82 0.81 0.84 0.76 0.75 0.84 0.83 0.80 0.87 0.79 0.77 0.77 0.84 0.81 0.85 0.79 0.78 (b) Real-world Network Football Senate MeDOC++ Ω EnDisCo MeDOC++ NMI ARI NMI ARI ONMI 0.86 0.87 0.87 0.90 0.81 0.78 0.89 0.91 0.90 0.92 0.87 0.79 0.87 0.88 0.89 0.92 0.84 0.80 0.91 0.89 0.90 0.93 0.82 0.82 0.78 0.79 0.80 0.81 0.76 0.75 Table 5: Relative percentage improvement (averaged over NMI and ARI) of ConsCl, EnDisCo and MeDOC++ over the baseline algorithms for disjoint community detection from synthetic networks. Each row corresponds to an algorithm Al and the value indicates the performance improvement of the ensemble approach with Al as the re-clustering algorithm over the isolated performance of Al without ensemble. Algorithm LFR (µ = 0.1) Synthetic Network LFR (µ = 0.3) LFR (µ = 0.6) ConsCl EnDisCo MeDOC++ ConsCl EnDisCo MeDOC++ ConsCl EnDisCo MeDOC++ FstGrdy Louvain CNM InfoMap WalkTrap LabelPr 1.92 1.86 1.98 0 3.43 3.90 2.39 1.97 2.07 0 4.43 5.06 2.93 2.04 2.46 0 4.97 5.72 1.96 1.90 2.03 0.98 3.91 4.01 2.71 2.22 2.14 1.44 4.86 5.12 3.02 2.40 2.83 1.62 5.08 5.39 1.90 1.97 2.01 1.62 5.05 4.96 3.81 3.41 3.22 2.01 6.98 7.50 3.91 3.86 3.50 2.46 7.42 7.82 sions that – (i) EnDisCo and MeDOC++ algorithms are quite competitive to the standalone algorithms for those networks which have prominent commu- nity structure; (ii) EnDisCo and MeDOC++ algorithms are more effective than the standalone algorithms for those networks whose underlying communities are weakly separated and difficult to detect by any traditional community detection algorithm. 24 Table 6: Relative percentage improvement (averaged over NMI and ARI) of ConsCl, EnDisCo and MeDOC++ over the baseline algorithms for disjoint community detection from real-world networks. Each row corresponds to an algorithm Al and the value indicates the performance improvement of the ensemble approach with Al as the re-clustering algorithm over the isolated performance of Al without ensemble. Real-world Network Algorithm Football Railway University Coauthorship ConsCl EnDisCo MeDOC++ ConsCl EnDisCo MeDOC++ ConsCl EnDisCo MeDOC++ ConsCl EnDisCo MeDOC++ FstGrdy Louvain CNM InfoMap WalkTrap LabelPr 0 0 0.84 0 1.42 2.23 0 0 1.23 0 2.21 3.01 0 0 1.46 0 2.46 3.29 1.01 0.96 1.01 1.10 2.13 2.21 1.22 1.17 1.49 1.22 3.21 3.46 1.43 1.43 1.92 1.56 3.49 3.79 1.92 1.76 1.54 1.76 3.01 4.32 2.20 2.12 2.39 2.01 4.22 6.21 2.86 2.30 2.40 2.20 4.49 6.80 2.23 1.87 1.32 1.98 4.02 4.32 3.98 2.21 2.92 2.31 5.06 6.21 4.60 2.39 3.41 2.98 5.51 6.98 Table 7: Actual accuracy values (in terms of NMI and ARI) of the proposed ensemble approaches (with default parameter setting) and ConsCl on both synthetic and real-world networks. Network ConsCl EnDisCo MeDOC++ NMI ARI NMI ARI NMI ARI 0.96 0.89 0.91 0.85 0.86 0.76 0.93 0.90 0.71 0.83 0.87 0.75 0.61 0.76 0.93 0.89 0.82 0.90 0.78 0.83 0.67 0.96 0.88 0.84 0.92 0.80 0.86 0.68 0.91 0.86 0.79 0.92 0.73 0.79 0.65 0.94 0.90 0.84 0.92 0.79 0.86 0.70 LFR(µ = 0.1) LFR(µ = 0.3) LFR(µ = 0.6) Football Railway University Coauthorship 6. Experiments: Results for Overlapping Community Detection In this section, we evaluate MeDOC++ for overlapping community detec- tion. We start by explaining the datasets used in this experiment, followed by the baseline algorithms used to compare our method and the evaluation metrics used to compare the detected communities with the ground-truth. We then show how to choose the best parameters followed by the comparative evaluation. 6.1. Datasets Here we briefly describe the synthetic and real-world networks that we use in this experiment. 6.1.1. Synthetic Networks We again use the LFR benchmark to generate synthetic networks with overlapping community structure with the following default parameter set- tings as mentioned in [30, 59]: n = 10000, ¯k = 50, kmax = 150, µ = 0.3, 25 Table 8: Properties of the real-world networks with overlapping community structure. N : number of vertices, E: number of edges, C: number of communities, ρ: average edge-density per community, S: average size of a community, Om: average number of community memberships per vertex. Network Senate Flickr Coauthorship LiveJournal Orkut N 1,884 80,513 391,526 3,997,962 3,072,441 E 16,662 5,899,882 873,775 34,681,189 117,185,083 C 110 171 8,493 310,092 6,288,363 ρ 0.45 0.046 0.231 0.536 0.245 S 81.59 470.83 393.18 40.02 34.86 Om 4.76 18.96 10.45 3.09 95.93 On = 20%, Om = 20, cmax = 100, cmin = 20. We generate 50 LFR networks for each parameter configuration - the experiments reported averages over these 50 networks. We further vary µ (0.1-0.8 with increment of 0.05), Om and On (both from 15% to 30% with increment of 1%) depending upon the experimental need. 6.1.2. Real-world Networks We also run experiments with following six real-world datasets mentioned in Table 8: Senate network: This network combines voting pattern of 110 US- Senates [75, 76]. Each vertex represents a senator and the senators are connected in that session to their 3 nearest neighbors measured by voting similarities. The ground-truth communities are marked based on the sena- tors who served in the same instance of the senate, i.e., senators who served during the same term. Flickr: This dataset is built by forming links between images sharing common metadata from Flickr [77]. Edges are formed between images from the same location, submitted to the same gallery, group, or set, images shar- ing common tags, images taken by friends, etc. Communities are the user- specified groups. Coauthorship: The coauthorship network [78] here is exactly the same as mentioned before for disjoint community structure in Section 5.1.2 except the ground-truth community marking which in this case is the publication venues (conferences or journals). LiveJournal: LiveJournal is a free on-line blogging community where users declare their friends. LiveJournal also allows users to form a group which other members can then join. Here user-defined groups are considered 26 as ground-truth communities. [45] provided the LiveJournal friendship social network and ground-truth communities. Orkut: In this datasets, users in Orkut social networking site are nodes, and links are their friendships. Ground-truth communities are user-defined groups. [45] provided the Orkut friendship social network and ground-truth communities. 6.2. Baseline Algorithms There are several standalone overlapping community detection algorithms, which are different based on the underlying working principle. We take six state-of-the-art algorithms from three different categories mentioned in [14]: (i) Local expansion: OSLOM [30] and EAGLE [40]; (ii) Agent-based dy- namical algorithms: COPRA [59] and SLPA [32], (iii) Detection using mixture model: MOSES [41] and BIGCLAM [45]. 6.3. Evaluation Metrics To compare the detected overlapping community structure with the ground- truth, we consider two standard validation metrics: Overlapping Normalized Mutual Information (ONMI)1 citeLancichinetti,journals and Omega Index (Ω Index) [79, 80]. The larger the value of ONMI and Omega index, the better the matching between two community structures. 6.4. Experimental Results In this section, we present a detailed description of the comparative evalu- ation of the competing algorithms for overlapping community detection. We first describe the parameter selection process for MeDOC++, followed by the results showing the impact of the base algorithms on MeDOC++. We then present the performance of the competing algorithms. 6.4.1. Parameter Settings We first try to identify the best parameter settings for MeDOC++. These include: matching function W , association function F, number of iterations K and threshold τ . Figure 4 shows the results on LFR networks by vary- ing µ, Om and On. The results are almost identical with that of disjoint setting shown in Figure 3. We observe that Jaccard coefficient as matching 1https://github.com/aaronmcdaid/Overlapping-NMI 27 Figure 4: Dependencies of MeDOC++ on different algorithmic parameters. The results are reported on default overlapping LFR networks by varying three parameters µ, Om and On. For thresholding, we choose top 5% and 10% highly probable communities for each vertex and compare it with our threshold selection method. The value corresponding to one parameter is reported by averaging the values for all possible combinations of the other parameters. The results are statistically significant. function and weighted association measure are better than their respective alternatives. The choice of K is the same as shown in Figure 3(f) – accu- racy almost levels off at K = 0.2V . We experiment with two choices of thresholding: top 5% and 10% most probable communities per vertex, and compare with the threshold selection mechanism described in Section 4.2. Figures 4(g) and 4(i) show that irrespective of any network parameter selec- tion, our choice of selecting threshold always outperforms others. As shown in Table 4, InfoMap seems to be the best choice for the re-clustering algo- rithm. Therefore unless otherwise stated, in the rest of the experiments, we run MeDOC++ with K = 0.2V , JC, Fw, InfoMap and τ (selected by our method). 6.4.2. Impact of Base Algorithms for Overlapping Community Detection The impact of the base algorithms on MeDOC++'s performance is similar to what we saw in the disjoint community detection case. The results in Table 3 show that accuracy decreases most when we drop InfoMap from the base algorithm, followed by Louvain and CNM. 28 0.20.40.60.80.70.80.9µ(a)152025300.70.80.9Om(b)152025300.750.80.850.9On(c) 0.20.40.60.80.70.8µONMI(d)152025300.70.8Om(e) 152025300.70.8On(f) 0.20.40.60.80.70.8µ(g)152025300.70.8Om(h)152025300.70.8On(i) JCAPF5%10%OurFwMatching Functionp=0.002p=0.007Association FunctionThresholdp=0.001p=0.001p=0.001p=0.004p=0.005p=0.009p=0.006 Table 9: Accuracy of all the competing algorithms in detecting the overlapping community structure from synthetic networks. All the disjoint algorithms are used to create the multipartite network and MeDOC++ is run with its default parameter setting. Algorithm OSLOM EAGLE COPRA SLPA MOSES BIGCLAM MeDOC++ Synthetic Networks LFR (µ = 0.1) ONMI Ω LFR (µ = 0.3) ONMI Ω LFR (µ = 0.6) ONMI Ω 0.80 0.81 0.80 0.84 0.85 0.86 0.88 0.78 0.83 0.81 0.86 0.86 0.85 0.91 0.74 0.75 0.76 0.78 0.80 0.81 0.84 0.78 0.76 0.74 0.77 0.81 0.83 0.87 0.72 0.70 0.72 0.76 0.75 0.77 0.82 0.73 0.74 0.74 0.77 0.78 0.79 0.84 Table 10: Accuracy of all the competing algorithms in detecting the overlapping commu- nity structure from real-world networks. All the disjoint algorithms are used to create the multipartite network and MeDOC++ is run with its default parameter setting. Algorithm OSLOM EAGLE COPRA SLPA MOSES BIGCLAM MeDOC++ Real-world Networks Senate Flickr ONMI 0.71 0.73 0.74 0.74 0.75 0.76 0.81 Ω 0.73 0.74 0.77 0.76 0.78 0.79 0.85 ONMI 0.68 0.69 0.73 0.72 0.74 0.75 0.79 Ω 0.74 0.76 0.78 0.74 0.76 0.76 0.84 Coauthorship ONMI Ω LiveJournal ONMI Ω 0.70 0.71 0.75 0.76 0.79 0.80 0.82 0.71 0.74 0.79 0.77 0.78 0.84 0.86 0.73 0.74 0.76 0.78 0.81 0.84 0.86 0.75 0.76 0.82 0.85 0.82 0.87 0.88 Orkut ONMI 0.71 0.70 0.74 0.75 0.78 0.81 0.83 Ω 0.76 0.77 0.76 0.79 0.82 0.84 0.86 6.4.3. Comparative Evaluation We run MeDOC++ with the default setting on three LFR networks and five real-world networks. The performance of MeDOC++ is compared with the six baseline overlapping community detection algorithms. Table 9 shows the performance of the competing algorithms in terms of ONMI and Ω index for synthetic network. In all cases, MeDOC++ is a clear winner, winning by significant margins. The absolute average of ONMI (Ω) for MeDOC++ over all synthetic networks is 0.85 (0.87), which is 4.50% (5.66%) higher than BIGCLAM, 6.25% (6.53%) higher than MOSES, 7.14% (8.75%) higher than SLPA, 11.84% (13.97%) higher than COPRA, 12.83% (12.01%) higher than EAGLE, and 12.38% (13.97%) higher than OSLOM. Another interesting observation is that for synthetic networks, the more the community structure deteriorates with the increase in µ, the harder it becomes to detect the communities. It is in 29 then "hard to detect" cases that the performance of MeDOC++ significantly improves compared to the baselines. Another interesting observation is that the performance improvement seems to be prominent with the deteriora- tion of community quality. For instance, the improvement of MeDOC++ with respect to the best baseline algorithm (BIGCLAM) is 2.32% (7.06%), 3.70% (4.82%) and 6.49% (6.33%) in terms of ONMI (Ω) with the increasing value of µ ranging from 0.1, 0.3 and 0.6 respectively. This once again corroborates our earlier observations in Section 5.4.4 that MeDOC++ is highly effective for those networks where the underlying community structure is not prominent and hard to detect. In Table 10, we show the performance of the competing algorithms on real-world networks. MeDOC++ once again outperforms other competing methods. The average absolute ONMI of MeDOC++ over all networks is 0.82, which is followed by BIGCLAM (0.79), MOSES (0.77), OSLOM (0.76), SLPA (0.75), COPRA (0.74) and EAGLE (0.71). In short, MeDOC++ performs the best irre- spective of any network and used validation measure. 7. Experiments: Results of Fuzzy Community Detection In the case of overlapping communities, there are two different ways of defining overlap – in crisp overlapping in which each vertex belongs to one or more communities (the membership is binary – there is no notion of the strength of membership in a communtiy); whereas in case of fuzzy overlap- ping, a vertex may also belong to more than one community but the strength of its membership to each community can vary. For instance, a person on Facebook might belong to multiple groups, but he may be much more active in one group compared to another. In this case, his degree of membership in that one group would be considered to be larger. We earlier observed in Step 9 of MeDOC++ that it can assign each vertex v to a community C with a membership probability of A(v, C). In this sec- tion, we provide a comprehensive analysis of the performance of MeDOC++ in detecting fuzzy community structure. We start by explaining the datasets used in this experiment, followed by the baseline algorithms and the evalua- tion metrics. We then describe the results of our comparative experimental evaluation. 30 7.1. Datasets We first describe the construction of synthetic networks with fuzzy com- munity structure, followed by the real-world network. 7.1.1. Synthetic Network The synthetic network generated by the LFR model [70] does not contain the fuzzy community structure. [43] proposed a modified version of the LFR model to generate synthetic fuzzy community structure. Here we adopt the their approach to generate synthetic networks. First, we generate crisp over- lapping communities from the LFR model. Second, the crisp communities are converted to fuzzy form by adding a random membership probability to each occurrence of a vertex. The membership probabilities are chosen from a uniform distribution. Next a network is constructed from the fuzzy communities using the following formula: pij = sijp1 + (1 − sij)p0 (3) where pij is the probability of the existence of an edge eij, sij is the co- membership of vertices i and j; and pij = p1 if ∃c ∈ C[i ∈ c∧ j ∈ c]; else p0. In the above equation, p0 and p1 are chosen so as to preserve the specified average degree (< k >) and mixing parameter (µ) in the generated LFR network. The final network then satisfies all of the original parameters of LFR with the exception of the degree distribution (kmax), maximum degree and τ1, the exponent of the power-law distribution of vertex degrees). How- ever, other parameters of LFR (such as µ, Om, On etc.) represent the same functionalities in this model. More details can be found in [43]2. Unless otherwise stated, we generate the synthetic networks with the following pa- rameter setting: n = 10000, ¯k = 50, kmax = 150, µ = 0.3, On = 20%, Om = 20, cmax = 100, cmin = 20. 7.1.2. Real-world Network There is no real-world network where fuzzy community memberships of vertices are known. Therefore, the existing fuzzy community detection al- gorithms were mostly tested either with synthetic networks [43, 81], or by calculating community evaluation metrics such as modularity [82]. Here we 2We took the implementation of the synthetic model by the author available at http: //www.cs.bris.ac.uk/~steve/networks/. 31 use the metadata information of the coauthorship network mentioned in Sec- tion 5.1.2 to construct the ground-truth. We recall that in the coauthorship network, authors are the vertices, edges are drawn based on coauthorship relations, and communities are different research areas. We then assign each author into a community with the community membership indicated by the fraction of papers the author has written on the corresponding research area. It also ensures that the sum of community memberships of each author is 1. 7.2. Baseline Algorithms Fewer fuzzy methods have been proposed in the past. [52] presented "FuzzyClust" that maps the problem to a nonlinear constrained optimiza- tion problem and solves it. [46] used the fuzzy c-means algorithm to detect up to communities after converting the network into the feature space. [83] presented a method based on Bayesian non-negative matrix factorization (NMF). Finally, FOG [84] clusters "link data", which includes networks as a special case, into fuzzy communities based on stochastic framework. [43] sug- gested "MakeFuzzy" algorithm which is used as a post-processing technique after a crisp overlapping algorithm to detect the fuzzy community structure. He further showed that MakeFuzzy along with EAGLE [40] outperforms other state-of-the-art algorithms. In our experiment, we consider FuzzyClust algorithm of [52] and the NMF algorithm of [83] (with default parameters) as two baseline algorithms. We also consider MakFuzzy+EAGLE (henceforth, named as "M-E") as another baseline to compare with MeDOC++. 7.3. Evaluation Metric There exist very few metrics for comparing two fuzzy community struc- tures. As per as we are aware, Fuzzy Rand Index (FRI) proposed by [85] is the only one metric for this purpose. Since this metric is used infrequently, we here explain this metric. This is a redefined version of the original Rand Index [43]: (4) RIu(C1, C2) = i,j∈V f (i, j, C1) − f (i, j, C2), and f (i, j, C1) = 1 is vertices vi and vj appear in the same community, 0 otherwise. Then the expected Rand Index is defined as: RIe(C1, C2) = s(C1)s(C2)+(N−s(C1))(N−s(C2)) , where s(C1, C2) = N −(cid:80) where N is the total number of vertices and s(C) =(cid:80) N 2 i,j∈V f (i, j, C). s(C1, C2) N 32 Table 11: Accuracy (in terms of Fuzzy Rand Index) of the fuzzy community detection algorithms for both synthetic and real-world networks. Synthetic networks are generated by varying µ and setting other parameters to default values. We run MeDOC++ in two set- tings – (i) MeDOC++: Algorithm 2 to detect fuzzy communities, (ii) MeDOC+++MakeFuzzy: crisp overlapping communities are detected by MeDOC++, followed by M-E to post-process the output. Algorithm FuzzyClust NMF M-E MeDOC++ MeDOC+++ MakeFuzzy LFR (µ = 0.1) LFR (µ = 0.3) LFR (µ = 0.6) Coauthorship Synthetic Real-world 0.71 0.74 0.78 0.78 0.78 0.68 0.70 0.74 0.75 0.76 0.65 0.68 0.71 0.70 0.73 0.62 0.65 0.67 0.68 0.68 The function f (i, j, C) indicates the extent to which i and j appear in the same community in C, which depends on the membership probability of vi and vj as follows: (cid:88) c∈C f (i, j, C) = 1 − 1 2 [αic − αjc] (5) where αic is the membership probability of i in community c. 7.4. Experimental Results We choose the same parameters for MeDOC++ as shown in Figure 4, i.e., K = 0.2V , JC as pair-wise similarly of communities, Fw as weighted as- sociation measure, InfoMap as re-clustering algorithm. Further, we consider two setups for MeDOC++: (i) MeDOC++ is run with the default parameter setting to detect the fuzzy community structure, (ii) MeDOC++ is run to detect the crisp overlapping community first, and then MakeFuzzy is used as a post-processing technique to detect the fuzzing overlapping communities (we call it MeDOC+++ MakeFuzzy). Table 11 presents the results of three baseline algorithms along with two setups of MeDOC++. We observe that both the setups of MeDOC++ tend to be very competitive with the M-E, which seems to be the best baseline algorithm. However, incorporating MakeFuzzy into MeDOC++ outperforms other competing algorithms with a significant margin. 33 8. Selection of Base Outputs In Section 5.4.2, we observed that removal of each base algorithm from the entire set reduces the overall accuracy of the ensemble algorithms with a certain extent. However, it was not clear (i) whether we need to consider all K outputs obtained from running each base algorithm K times, (ii) whether a subset of base algorithms are enough to get similar accuracy. In this section, we address these questions. In particular, we ask a general question - given a large set of different base solutions, how do we select a subset of solutions to form a smaller yet better performing ensemble algorithm than using all the available base solutions? To this end, we investigate two properties of the detected solutions that have already been identified to be effective in literature [86, 87, 88, 89] – the quality and the diversity. 8.1. Defining Quality and Diversity Quality. Since the original communities to which vertices in a network belong are not known a priori, we propose to use an internal quality measure as follows. Given an ensemble solution E combining the set of all base community structures Γ = {Ck m},∀m ∈ M ∧ k ∈ K, the following quality function is used to measure the similarity of each solution with the ensemble: (cid:88) K(cid:88) m(cid:48)∈M n=1 Quality(Ck m, Γ) = Q(Ck m, Cn m(cid:48)) (6) Q can be any of the standard evaluation metrics such as NMI, ARI men- tioned in Section 5.3 for disjoint communities and ONMI, Omega index in Section 6.3 for overlapping communities. However, we use NMI and ONMI for disjoint and overlapping communities respectively as suggested by Strehl and Ghosh [90]. Intuitively, Quality measures how well a particular base solution agrees with the general trend present in Γ. Diversity. There are many different diversity measures proposed for cluster ensembles in data mining [91]. However, to make the function consistent with the quality measure, we consider pair-wise NMI/ONMI among the base solutions. In particular, we measure the pair-wise similarity of two base solutions as Q(Ck m(cid:48)) and compute the sum of all pair-wise similarities j ). The lower the value, the higher the j ∈Γ i(cid:54)=j∧i,j∈M∧k,k(cid:48)∈K∧Ck m, Ck(cid:48) i ,Ck(cid:48) Q(Ck i , Ck(cid:48) (cid:80) 34 diversity. We consider this diversity measure because it has already been shown to be effective for cluster ensemble [92]. Note that the base solution selection strategies that we will present here do not limit themselves to any particular quality and diversity functions. 8.2. Selection Strategies Among the M K number of solutions obtained from base community de- tection algorithms, we select S solutions based on the following criteria indi- vidually: 8.2.1. Only Quality This strategy simply ranks all solutions based on Quality and selects top S solutions to include in the ensemble algorithm. The solution with the highest Quality essentially indicates that it has high consistency with the rest of the solutions. Generally, we expect that if we take only high quality solutions, due to the high similarity among them this strategy may lead to huge redundancy in the chosen set of solutions. This in turn reduces the ability to obtain improved results for those portions of the data which none of the selected solutions is able to capture properly. This explains the need for diversity amongst the solutions. 8.2.2. Only Diversity We consider a greedy solution to select S solutions which are highly di- verse. We start by selecting the solution with highest Quality3. We then incrementally add one solution at a time such that the resulting ensemble has the highest diversity. This process continues until the required number of solutions are chosen. It is commonly believed that diversifying the base solution is beneficial because mistakes made by one base algorithm may be compensated by another. However, it may result in the inclusion of low quality solutions in the ensemble. This is one of the reasons to choose the solution with highest quality first in the greedy strategy. 3However, one can start by selecting the solution which has highest pair-wise diversity. However, we observed that it ended up selecting poor solutions in the ensemble which leads to decrease in performance. 35 Figure 5: (a) A hypothetical network; (b) top three vertices found using PageRank are highlighted with large circles, and (c) top three nodes found using VRRW are highlighted with large circles. This example is taken from [94]. 8.2.3. Combining Quality and Diversity There is always a trade-off between quality and diversity in selecting base solutions, which can be viewed as a multi-objective optimization framework. A traditional way of handling such problems is to combine them into a single aggregate objective function. We choose S such solutions, denoted by CS that maximize the following objective function: (1 − Q(ci, cj)) (7) (cid:125) (cid:88) c∈CS J = α (cid:124) Quality(c, Γ) (cid:123)(cid:122) Quality (cid:125) + (1 − α) (cid:124) (cid:88) (cid:123)(cid:122) ci,cj∈CS ,ci(cid:54)=cj , Diversity The parameter α controls the trade-off between these two quantities. However, it is computationally expensive to select S solutions out of M K solutions [93]. Therefore, we adopt the following greedy strategy. We start by adding the solution with highest quality and incrementally add solutions one at a time that maximizes J. We set 0.5 as the default value of α. However, we will examine different choices of α in Figure 8. 8.2.4. PageRank-based Selection This approach leverages the well-known PageRank algorithm to select the top S solutions which are of high quality but which are as diversely sepa- rated in the network as possible. We adopt Vertex Reinforced Random Walk (VRRW), a time heterogeneous random walk process used by [95]. Let us as- sume that we construct a network, where vertices are the base solutions and 36 (a) A hypothetical network(b) Ranking based on PageRank(c) Ranking based on VRRW the weight of an edge connecting two vertices i and j indicates the pair-wise diversity (1−Q) between corresponding base solutions. Unlike in traditional PageRank where the transition probabilities remain static throughout the iterations, in VRRW they change over time/iteration based on the following equation: pT (i, j) = (1 − λ) · p∗(j) + λ · p0(i, j) · pT (j) DT (i) (8) (9) where DT (i) = p0(i, j)pT (k) (cid:88) k∈V walk is at vertex k at time T : pT (k) = (cid:80) Here, pT (i, j) is the transition probability from vertex i to vertex j at time T , p∗(j) is a distribution which represents the prior preference of visiting vertex j, p0(i, j) is the "organic" transition probability prior to any reinforcement. λ is set to 0.9 as suggested by [94]. pT (k) denotes the probability that the (n,k)∈E pT (n, k)pT−1(n). We set p∗(j) = Quality(Cj, Γ) and p0(i, j) as follows: (1−Q(Ci,Cj )) W eighted deg(Ci) 1 − α, if i (cid:54)= j otherwise p0(i, j) = (cid:40) α · (10) where W eighted deg(Ci) is the weighted degree of vertex i, representing com- munity structure Ci. A schematic diagram of the VRRW process compared to PageRank is presented in Figure 54. In this strategy, vertices are ranked based on VRRW score at the stationary state. Then we collect top S high ranked vertices, which in turn produces S high quality base communities which are diversely separated in the network. 8.3. Experimental Results To evaluate the ensemble selection strategies, we apply each strategy on all the datasets separately for disjoint and overlapping community detections. The results are reported by averaging the values after ten independent runs. In Figures 6 and 7 we plot the performance of different selection strategies as a function of ensemble size S (where S is represented as a fraction of the full ensemble set). We also show the results after considering all the base solutions in the ensemble set using the horizontal green line. 4Readers are encouraged to read the details in [95]. 37 It is evident from both these results that the full ensemble is always best. However, we might achieve the same performance by selecting a subset of the base solutions. Both "combining quality and diversity" and "VRRW" strate- gies seem to be more consistent and achieve promising performance toward our goal, that is to select smaller and better performing ensembles. Among them, the VRRW-based strategy tends to achieve the maximum accuracy with just 60-80% size of the full ensemble. For the large networks such as Coauthorship network in Figure 6(d), the separation of the performance is much prominent for EnDisCo and VRRW-based strategy reaches the maxi- mum accuracy with 40% of the full ensemble. The reason might be that this strategy explicitly seeks to remove redundant solutions and retains quality solutions at the same time. Sensitivity of α for "combining quality and diversity" strategy: So far we conducted all the experiments with α = 0.5 for "combining quality and diversity" strategy. Here we examine how this strategy gets affected by varying the value of α. We experiment with a variety of α values including 0, 0.1··· , 0.9, 1 and compare the results with "only quality" (α = 1) and "only diversity" (α = 0). The smaller values of α takes "diversity" into ac- count; whereas larger values prefer "quality". In Figure 8, we present the results of EnDisCo and MeDOC++ for both disjoint and overlapping com- munity detection by varying the size of the selected base solutions and five different values of α (0, 0.3, 0.5, 0.7, 1). Note that each accuracy value shown here is the average of ten runs. In general, we observe that assigning very high or very low values to α might be beneficial for some cases, but in general the result is more stable and robust for α = 0.5. We also observe that the accuracy never decreases with the increase of S and gets saturated quickly for α = 0.5. 9. Other Implications of MeDOC++ In this section, we present two other useful capabilities of MeDOC++. We show that MeDOC++ can be used to explore the core-periphery structure of communities in a network and to detect stable communities from dynamic networks. 38 Figure 6: Comparison of the performance of different selection strategies: OQ: only qual- ity, OD: only diversity, Q+D: combining quality and diversity with α = 0.5, VRRW: vertex reinforced random walk, with the variation of the size of the base solutions for disjoint community detection. We compare the performance of these strategies with the full ensemble (Full) represented by the solid green line. 9.1. Exploring Community-centric Core-periphery Structure The association values of individual vertices in a community obtained from MeDOC++ provide additional information about the membership strength in that community. This phenomenon might be related to the core-periphery organization [96, 97] of the induced subgraph composed of the vertices in a community. We hypothesize that the more the association of a vertex in a community, the more the vertex is likely to be a core part of the community. To verify this, we first explore the core-periphery structure (also known as k-core decomposition [97]) of each community in a network. Core-periphery organization: For each community detected by MeDOC++, we start by creating the induced subgraph composed of vertices in that com- munity. We then recursively remove vertices which have degree one until no such degree-one vertices remain in the network. The removed vertices form the 1-shell of the network (ks -shell index ks = 1). Similarly, we obtain 2- shell by recursively removing degree-two vertices from the resultant network obtained from the last stage. We keep on increasing the value of k until all 39 0.20.40.60.810.450.50.550.60.650.7(h) MeDOC++ (Coauthorship)0.20.40.60.810.30.40.50.60.7(d) EnDisCo (Coauthorship)S, number of base solutions (represented as a fraction of the size of full ensemble MK)0.20.40.60.810.50.60.70.80.9(g) MeDOC++ (University)0.20.40.60.810.30.40.50.60.70.8(f) MeDOC++ (Railway)0.20.40.60.81NMI0.40.50.60.70.80.91(e) MeDOC++ (Football)0.20.40.60.810.40.50.60.70.80.9(c) EnDisCo (University)0.20.40.60.810.40.50.60.70.8(b) EnDisCo (Railway)0.20.40.60.81NMI0.50.60.70.80.9(a) EnDisCo (Football)OQODQ+DVRRWFull Figure 7: Comparison of the performance of different selection strategies: OQ: only qual- ity, OD: only diversity, Q+D: combining quality and diversity with α = 0.5, VRRW: vertex reinforced random walk, with the variation of the size of the base solutions for overlapping community detection. We compare the performance of these strategies with the full ensemble (Full) represented by the solid green line. the vertices are assigned to at least one shell. Then the ks-core is formed by taking the union of all the shells with index greater than or equal to ks. The idea is to show how the association value of a vertex to a community is related to its community-centric shell-index5. For each network, we first detect the community using MeDOC++ and measure the association values of vertices. Then, for each detected community, we extract the core-periphery structure. In Figure 9, we present the correlation between association values of vertices with their positions in the core-periphery structure. For better visualization, we divided the total number of shells into three broad shells, and the range of association value into four buckets. We note that the inner core is highly dominated by the vertices with association value ranging 0.75− 1, whereas the outermost layer is dominated by vertices having association value 0 − 0.25. Further, we observe that as we move from core to periphery, vertices with low association score start dominating. This result indicates that the association value derived from MeDOC++ has high correlation with 5Note that the average core-periphery structure of communities in a network is different from the core-periphery structure of a network. Here we are interested in the former case. 40 0.20.40.60.81ONMI0.40.50.60.70.80.9(a) MeDOC++ (Senate)OQODQ+DVRRWFull0.20.40.60.810.30.40.50.60.70.8(b) MeDOC++ (Flickr)0.20.40.60.810.40.50.60.70.80.9(c) MeDOC++ (Coauthorship)S, number of base solutions (represented as a fraction of the size of full ensemble MK)0.20.40.60.81ONMI0.40.50.60.70.80.9(d) MeDOC++ (LiveJournal)0.20.40.60.810.50.60.70.80.9(e) MeDOC++ (Orkut) Figure 8: Sensitivity of the "Combining quality and diversity" strategy by varying the parameter α (0, 0.3, 0.5, 0.7, 1) for different sizes of the selected based solutions (S). S is represented as a fraction of the size of full ensemble (M K), i.e., the size of the base solutions when all base solutions are taken. (a)-(h) Results of EnDisCo and MeDOC++ for disjoint community detection. (i)-(m) Results of MeDOC++ for overlapping community detection. the core-periphery origination of the community structure. 9.2. Discovering Stable Communities in Dynamic Networks Most real-world networks are dynamic – either vertices or edges get added to the network or get deleted over time. As a result, the community structure of the network might change over time. [98] argued that despite the change in community structure, there are some stable communities that persist. Such stable communities may be important for many reasons. For instance, in an election campaign, vertices in stable communities might be individuals who are strong supporters of a particular candidate. In human interaction networks, the stable communities might be the groups of individuals who are close friends or family members. For instance, there are a number of efforts [99] in which researchers have provided subjects with cell phones (or cell phone apps), and a temporal human interaction network is built by identifying mobile phones that are in close proximity with one another during a given time window. In such cases, communities that are stable between 8am 41 0.10.51NMI0.50.60.70.80.9(a) EnDisCo (Football)0.10.510.20.40.60.8(b) EnDisCo (Railway)0.10.510.40.60.81(c) EnDisCo(University)α=0α=0.3α=0.5α=0.7α=10.10.510.30.40.50.60.7(d) EnDisCo(Coauthorship)0.10.51NMI0.40.60.81(e) MeDOC++(Football)0.10.510.40.50.60.70.8(f) MeDOC++(Railway)0.10.510.40.60.81(g) MeDOC++(University)0.10.510.30.40.50.60.7(h) MeDOC++(Coauthorship)0.10.51ONMI0.40.60.81(i) MeDOC++ (Senate)0.10.510.20.40.60.8(j) MeDOC++(Flickr)S, number of the selected base solutions (represented as a fraction of the size of full ensemble MK)0.10.510.40.60.81(k) MeDOC++ (Coauthorship)0.10.510.50.60.70.80.9(l) MeDOC++ (LiveJournal)0.10.510.20.40.60.81(m) MeDOC++ (Orkut) Figure 9: Core-periphery organization of the disjoint (top panel) and overlapping (bottom panel) communities detected by MeDOC++ and its relation with the association values. The colors represent different ranges of association values and the area covered by each colored region in each ks-shell denotes the proportion of vertices with the corresponding association values occupied in that shell. The innermost shell is the core region and the outermost shell is the periphery region. For better visualization, we divide the total number of shells identified from the communities in each network into three broad shells and the range of association values into four buckets; thus the core-periphery structure in each network has three concentric layers and each layer is divided into four association ranges. and 6pm might represent people who work together, while communities that are stable during the 8pm to 6am time frame might represent families. We hypothesize that the association values of individual vertices obtained via the MeDOC++ algorithm can discover stable communities in dynamic networks. In particular, vertices with an association value tending to 1 might form stable communities in a network. To this end, we collect two dynamic networks with unknown ground- truth community structure6 [100]: (i) Hypertext 2009 contact network: this is a dynamic network of face-to-face proximity over about 2.5 days of 110 attendees who attended ACM Hypertext 2009 conference, (ii) School contact network: this dataset contains the temporal network of contacts between 298 students over 4 days in a high school in Marseilles, France. We divide each network into five subnetworks based on the equal division of the temporal 6http://www.sociopatterns.org/datasets/ 42 Table 12: Similarity of the stable communities of temporal networks in two consecutive time stamps obtained from MeDOC++ for two dynamic networks (Hypertext and school contact networ). Network Measure Hypertext School NMI ARI NMI ARI t1 − t2 0.79 0.81 0.76 0.75 t2 − t3 0.76 0.78 0.79 0.76 t3 − t4 0.80 0.79 0.78 0.82 t4 − t5 0.82 0.83 0.80 0.83 dimension in such a way that number of vertices is same in each subnetwork. However the edge connectivity might vary across five time windows. In each time window ti, we run MeDOC++ on the corresponding network. We allow MeDOC++ to detect communities with the default parameter set- ting. Once we obtain the association matrix A (in Step 5 of Algorithm 2), we considered only those vertices whose association score is exactly 1 and group them accordingly (resulting disjoint stable community structure). We believe that these vertices form the stable communities. We repeat the same procedure for each temporal network separately and detect the stable com- munity structure. Then we measure the similarity (based on NMI and ARI) between stable community structures obtained from the temporal networks in two consecutive time windows (ti and ti+1) , where i ranges from 1 to 4) of each dynamic network. In Table 12, we observe that the temporal similarity between two consecutive stable communities is quite high, and it remains al- most same over time. This indicates that the stable community structure of a network do not vary much over the successive time periods, and MeDOC++, quite efficiently, detects such stable communities from dynamic networks. 10. Handling Degeneracy of Solutions Most community finding algorithms suffer from the well-known "degen- eracy of solutions" problem [10] which states that these algorithms typically produce exponentially many solutions with (nearly-)similar optimal value of the objective function (such as modularity); however the solutions may be structurally distinct from each other. We hypothesize that since ensemble algorithms combine multiple views of the underlying community structure of a network, they might suffer less from the problem of degeneracy of solutions. We test this by considering the 43 Figure 10: Box plots indicating the variation of the solutions obtained from the disjoint community finding algorithms on real-world networks. real-world networks, and running each competing algorithms on 100 different vertex orderings of each network. We then measure the pair-wise similarity of the solutions obtained from each algorithm. The box plots in Figures 10 and 11 show the variation of the solutions for all the competing algorithms on both disjoint and overlapping community detections respectively. We observe that the median similarity is high with EnDisCo and MeDOC++ and the variation is significantly less. In fact, all the ensemble algorithms, i.e., EnDisCo, MeDOC++ and ConsCl show low variance. These results suggest that ensemble based algorithms always provide more robust results than standalone algorithms and alleviate the problem of degeneracy of solutions. 11. Runtime Analysis Since ensemble approaches require the running all base algorithms (which may be parallelized), one cannot expect ensemble methods to be faster than standalone approaches. However, our proposed ensemble frameworks are much faster than existing ensemble approaches such as consensus clustering. To show this, for each ensemble algorithm, we report Θ, the ratio between the runtime of each ensemble approach and the sum of runtimes of all base algorithms, with increasing number of vertices in LFR. We vary the number 44 1234567890.80.850.9(a) Football1234567890.60.650.70.750.8(b) RailwayDisjoint community finding algorithm123456789Pair-wise similarity (based of NMI)0.650.70.750.80.850.9(c) University1234567890.450.50.550.60.650.7(d) Coauthorship1. FstGrdy2. Louvain3. CNM4. Infomap5. walkTrap6. LabelPr7. ConsCl8. EnDisCo9. MeDOC++ Figure 11: Box plots indicating the variation of the solutions obtained from the overlapping community finding algorithms on real-world networks. Figure 12: The value of Θ w.r.t. the increase of vertices in LFR networks. EnDisCo and MeDOC++ are compared with ConsCl. The results are statistically significant (since there are multiple curves, we report the range of p-values). of edges of LFR by changing µ from 0.1 to 0.3. Figure 12 shows that our algorithms are much faster than consensus clustering. We further report the results of MeDOC++ for overlapping community detection which is almost same as that of disjoint case since it does not require additional steps apart from computing the threshold. 45 1234567Pair-wise similarity (based on ONMI)0.60.650.70.750.80.85(a) Senate12345670.60.650.70.750.8(b) Flickr12345670.60.650.70.750.80.85(c) CoauthorshipOverlapping community finding algorithm12345670.60.70.80.9(d) LiveJournal12345670.60.650.70.750.80.85(e) Orkut1. OSLOM2. EAGLE3. COPRA4. SLPA5. MOSES6. BIGCLAM7. MeDOC++Number of vertices200040006000800010000Θ11.522.53Disjoint community detectionEnDisCoMeDOC++ConsClEnDisCoMeDOzConsClNumber of vertices200040006000800010000Θ11.522.5Overlapping community detectionµ=0.1µ=0.3µ=0.6(b)(a)MeDOC++Dotted lines: µ =0.1Solid lines: µ=0.3p<0.005p<0.005 12. Conclusion In this paper, we proposed two general frameworks for ensemble com- munity detection. EnDisCo identifies disjoint community structures, while MeDOC++ detects both disjoint, overlapping and fuzzy community structures. MeDOC++ is the first ever ensemble overlapping (and fuzzy) community de- tection algorithms in the literature. We tested our algorithms on both synthetic data using the LFR bench- mark as well as with several real-world datasets that have an associated ground-truth community structure. We showed that both EnDisCo and MeDOC++ are more accurate than existing standalone community detection algorithms (though of course, EnDisCo and MeDOC++ leverage them by us- ing the known community detection algorithms in the ensembles). We fur- ther showed that for disjoint community detection problems, EnDisCo and MeDOC++ both beat the best performing existing disjoint ensemble method called consensus clustering [8] – both in terms of accuracy and run-time. To our knowledge, MeDOC++ is the first ensemble algorithm for overlapping and fuzzy community detection that we have seen in the literature. We further presented extensive analysis of how to select a subset of so- lutions to obtain near-optimal accuracy. The association values of vertices obtained from MeDOC++ help us exploring the core-periphery structure of the communities in a network and detecting the stable communities in dynamic networks. We showed that ensemble approaches generally reduce the effect of degeneracy of solution significantly. References References [1] S. Fortunato, Community detection in graphs, Physics Reports 486 (2010) 75 – 174. [2] M. E. Newman, Modularity and community structure in networks, PNAS 103 (2006) 8577–8582. [3] V. A. Traag, G. Krings, P. V. Dooren, Significant scales in community structure, Scientific Reports 3 (2013). 46 [4] T. Chakraborty, S. Srinivasan, N. Ganguly, A. Mukherjee, S. Bhowmick, On the permanence of vertices in network communi- ties, in: SIGKDD, New York, USA, pp. 1396–1405. [5] T. Chakraborty, Leveraging disjoint communities for detecting overlap- ping community structure, Journal of Statistical Mechanics: Theory and Experiment 2015 (2015) P05017. [6] T. Chakraborty, S. Srinivasan, N. Ganguly, A. Mukherjee, S. Bhowmick, Permanence and community structure in complex net- works, ACM Trans. Knowl. Discov. Data 11 (2016) 14:1–14:34. [7] J. Dahlin, P. Svenson, Ensemble approaches for improving community detection methods., CoRR abs/1309.0242 (2013). [8] A. Lancichinetti, S. Fortunato, Consensus clustering in complex net- works, Nature Scientific Reports 2 (2012). [9] R. Xu, D. Wunsch, II, Survey of clustering algorithms, Trans. Neur. Netw. 16 (2005) 645–678. [10] B. Good, Y. D. Montjoye, A. Clauset, Performance of modularity max- imization in practical contexts, Physical Review E 81 (2010) 046106. [11] T. Chakraborty, S. Srinivasan, N. Ganguly, S. Bhowmick, A. Mukher- jee, Constant Communities in Complex Networks, Scientific Reports 3 (2013). [12] T. Chakraborty, N. Park, V. Subrahmanian, Ensemble-based algo- rithms to detect disjoint and overlapping communities in networks, in: 2016 IEEE/ACM International Conference on Advances in Social Net- works Analysis and Mining (ASONAM), pp. 73–80. [13] T. Chakraborty, A. Dalmia, A. Mukherjee, N. Ganguly, Metrics for community analysis: A survey, ACM Comput. Surv. 50 (2017) 54:1– 54:37. [14] J. Xie, S. Kelley, B. K. Szymanski, Overlapping community detection in networks: The state-of-the-art and comparative study, ACM Comput. Surv. 45 (2013) 43:1–43:35. 47 [15] V. D. Blondel, J.-L. Guillaume, R. Lambiotte, E. Lefebvre, Fast un- folding of communities in large networks, J. Stat. Mech (2008) P10008. [16] A. Clauset, M. E. J. Newman, , C. Moore, Finding community struc- ture in very large networks, Phys. Rev. E 70 (2004) 066111. [17] R. Guimera, L. A. N. Amaral, Functional cartography of complex metabolic networks, Nature 433 (2005) 895–900. [18] M. E. J. Newman, Fast algorithm for detecting community structure in networks, Phys. Rev. E 69 (2004) 066133. [19] M. E. J. Newman, Community detection and graph partitioning, CoRR abs/1305.4974 (2013). [20] T. Richardson, P. J. Mucha, M. A. Porter, Spectral tripartitioning of networks, Phys. Rev. E 40 (2009) 027104. [21] I. Farkas, D. ´Abel, G. Palla, T. Vicsek, Weighted network modules, New Journal of Physics 9 (2007) 180. [22] G. Palla, I. Der´enyi, I. Farkas, T. Vicsek, Uncovering the overlapping community structure of complex networks in nature and society, Nature 435 (2005) 814–818. [23] J. Baumes, M. Goldberg, M. Magdon-Ismail, Efficient identification in: Proceedings of the 2005 IEEE inter- of overlapping communities, national conference on Intelligence and Security Informatics, ISI'05, Springer-Verlag, Berlin, Heidelberg, 2005, pp. 27–36. [24] A. Lancichinetti, S. Fortunato, J. Kertesz, Detecting the overlapping and hierarchical community structure of complex networks, ArXiv E- prints (2008). [25] P. De Meo, E. Ferrara, G. Fiumara, A. Provetti, Enhancing community detection using a network weighting strategy, Journal of Information Science 222 (2013) 648–668. [26] P. Pons, M. Latapy, Computing communities in large networks using random walks, J. Graph Algorithms Appl. 10 (2006) 191–218. 48 [27] M. Rosvall, C. Bergstrom, An information-theoretic framework for resolving community structure in complex networks, PNAS 104 (2007) 7327. [28] M. Rosvall, C. T. Bergstrom, Maps of random walks on complex net- works reveal community structure, PNAS 105 (2008) 1118–1123. [29] U. N. Raghavan, R. Albert, S. Kumara, Near linear time algorithm to detect community structures in large-scale networks, Phys. Rev. E 76 (2007) 036106. [30] A. Lancichinetti, F. Radicchi, J. J. Ramasco, S. Fortunato, Finding statistically significant communities in networks, PLoS ONE 6 (2011) e18961. [31] J. Xie, B. Szymanski, Community detection using a neighborhood strength driven label propagation algorithm, in: IEEE NSW, pp. 188– 195. [32] J. Xie, B. K. Szymanski, Towards linear time overlapping community detection in social networks, in: PAKDD, Malaysia, pp. 25–36. [33] J. Xie, M. Chen, B. K. Szymanski, Labelrankt: Incremental com- munity detection in dynamic networks via label propagation, CoRR abs/1305.2006 (2013). [34] V. Kawadia, S. Sreenivasan, Sequential detection of temporal commu- nities by estrangement confinement, Scientific Reports 2 (2012). [35] B. Mitra, L. Tabourier, C. Roth, Intrinsically dynamic network com- munities, CoRR abs/1111.2018 (2011). [36] D. A. Bader, H. Meyerhenke, P. Sanders, D. Wagner (Eds.), Graph Partitioning and Graph Clustering - 10th DIMACS Implementation Challenge Workshop, Georgia Institute of Technology, Atlanta, GA, USA, February 13-14, 2012. Proceedings, volume 588 of Contemporary Mathematics, American Mathematical Society, 2013. [37] J. Riedy, D. A. Bader, K. Jiang, P. Pande, R. Sharma, Detecting Com- munities from Given Seeds in Social Networks, Technical Report GT- CSE-11-01, Georgia Institute of Technology, 2011. 49 [38] S. Fortunato, A. Lancichinetti, Community detection algorithms: A comparative analysis: in: Fourth International ICST Conference on Performance Evaluation Methodologies and Tools, ICST, Brussels, Belgium, Belgium, pp. 27:1– 27:2. Invited presentation, extended abstract, [39] Y.-Y. Ahn, J. P. Bagrow, S. Lehmann, Link communities reveal mul- tiscale complexity in networks, Nature 466 (2010) 761–764. [40] K. C. H. Shen, X. Cheng, M. B. Hu, Detect overlapping and hierarchical community structure in networks, Physica A 388 (2009) 1706–1712. [41] A. McDaid, N. Hurley, Detecting highly overlapping communities with model-based overlapping seed expansion, in: ASONAM, Washington, DC, USA, pp. 112–119. [42] C. Lee, F. Reid, A. McDaid, N. Hurley, Detecting highly-overlapping community structure by greedy clique expansion, in: ACM KDD-SNA, pp. 33–42. [43] S. Gregory, Fuzzy overlapping communities in networks, Journal of Statistical Mechanics: Theory and Experiment 2011 (2011) P02017. [44] K. Zhao, S.-W. Zhang, Q. Pan, Fuzzy analysis for overlapping com- munity structure of complex network, in: CCDC, pp. 3976–3981. [45] J. Yang, J. Leskovec, Overlapping community detection at scale: A in: WSDM, ACM, New nonnegative matrix factorization approach, York, USA, 2013, pp. 587–596. [46] S. Zhang, R.-S. Wang, X.-S. Zhang, Identification of overlapping com- munity structure in complex networks using fuzzy c-means clustering, Physica A: Statistical Mechanics and its Applications 374 (2007) 483– 490. [47] J. Baumes, M. K. Goldberg, M. S. Krishnamoorthy, M. Magdon-Ismail, N. Preston, Finding communities by clustering a graph into overlapping subgraphs., in: IADIS AC, IADIS, 2005, pp. 97–104. [48] A. Lancichinetti, S. Fortunato, J. Kert´esz, Detecting the overlapping and hierarchical community structure in complex networks, New J. Phys. 11 (2009) 033015. 50 [49] F. Havemann, M. Heinz, A. Struck, J. Glser, Identification of overlapping communities and their hierarchy by locally calculating community-changing resolution levels, JSTAT 2011 (2011) P01023. [50] D. Chen, M. Shang, Z. Lv, Y. Fu, Detecting overlapping communities of weighted networks via a local algorithm, Physica A 389 (2010) 4177 – 4187. [51] N. Du, B. Wang, B. Wu, Overlapping community structure detection in networks, in: CIKM, ACM, New York, USA, 2008, pp. 1371–1372. [52] T. Nepusz, A. Petr´oczi, L. N´egyessy, F. Bazs´o, Fuzzy communities and the concept of bridgeness in complex networks, Phys. Rev. E 77 (2008) 016107. [53] M. E. J. Newman, E. A. Leicht, Mixture models and exploratory analysis in networks, PNAS 104 (2007) 9564–9569. [54] W. Ren, G. Yan, X. Liao, L. Xiao, Simple probabilistic algorithm for detecting community structure, Phys. Rev. E 79 (2009) 036111. [55] K. Nowicki, T. A. B. Snijders, Estimation and prediction for stochastic blockstructures, Journal of the American Statistical Association 96 (2001) 1077–1087. [56] M. Zarei, D. Izadi, K. A. Samani, Detecting overlapping community structure of networks based on vertex–vertex correlations, J. Stat. Mech. Theor. Exp. 2009 (2009) P11013. [57] F. Ding, Z. Luo, J. Shi, X. Fang, Overlapping community detection by kernel-based fuzzy affinity propagation, in: ISA, pp. 1–4. [58] J. J. Whang, D. F. Gleich, I. S. Dhillon, Overlapping community detection using seed set expansion, in: CIKM, ACM, 2013, pp. 2099– 2108. [59] S. Gregory, Finding overlapping communities in networks by label propagation, New J. Phys. 12 (2010) 103018. [60] W. Chen, Z. Liu, X. Sun, Y. Wang, A game-theoretic framework to identify overlapping communities in social networks, Data Min. Knowl. Discov. 21 (2010) 224–240. 51 [61] S. Gregory, An algorithm to find overlapping community structure in in: PKDD, Springer-Verlag, Berlin, Heidelberg, 2007, pp. networks, 91–102. [62] M. Girvan, M. E. J. Newman, Community structure in social and biological networks, PNAS 99 (2002) 7821–7826. [63] Y. Zhang, J. Wang, Y. Wang, L. Zhou, Parallel community detection on large networks with propinquity dynamics., in: KDD, ACM, 2009, pp. 997–1006. [64] A. Istv´an, R. Palotai, M. S. Szalay, P. K. Csermely, Community land- scapes: An integrative approach to determine overlapping network module hierarchy, identify key nodes and predict network dynamics, PLoS ONE 5 (2010) e12528. [65] P.-G. Sun, L. Gao, S. S. Han, Identification of overlapping and non- overlapping community structure by fuzzy clustering in complex net- works, Inf. Sci. 181 (2011) 1060–1071. [66] M. Ovelgonne, A. Geyer-Schulz, An ensemble learning strategy for graph clustering, in: Graph Partitioning and Graph Clustering, volume 588 of Contemporary Mathematics, American Mathematical Society, 2012, pp. 187–206. [67] R. Kanawati, Yasca: An ensemble-based approach for community de- in: COCOON, Springer, Cham, 2014, tection in complex networks, pp. 657–666. [68] R. Kanawati, YASCA: A collective intelligence approach for commu- nity detection in complex networks, CoRR abs/1401.4472 (2014). [69] R. Kanawati, Ensemble selection for community detection in complex networks, in: SCSM, Springer, CA, USA, 2015, pp. 138–147. [70] A. Lancichinetti, S. Fortunato, Benchmarks for testing community detection algorithms on directed and weighted graphs with overlapping communities, Phy. Rev. E 80 (2009) 016118. [71] T. Chakraborty, S. Sikdar, V. Tammana, N. Ganguly, A. Mukherjee, Computer science fields as ground-truth communities: their impact, rise and fall, in: ASONAM, ACM, 2013, pp. 426–433. 52 [72] G. K. Orman, V. Labatut, H. Cherifi, Comparative evaluation of com- munity detection algorithms: a topological approach, Journal of Sta- tistical Mechanics: Theory and Experiment 2012 (2012) P08001. [73] L. Danon, A. Diaz-Guilera, J. Duch, A. Arenas, Comparing community structure identification, J. Stat. Mech. 9 (2005) P09008. [74] L. Hubert, P. Arabie, Comparing partitions, Journal of classification 2 (1985) 193–218. [75] L. G. S. Jeub, P. Balachandran, M. A. Porter, P. J. Mucha, M. W. Ma- honey, Think locally, act locally: Detection of small, medium-sized, and large communities in large networks, Phys. Rev. E 91 (2015) 012821. [76] K. Kloster, D. F. Gleich, Personalized pagerank solution paths, CoRR abs/1503.00322 (2015). [77] X. Wang, L. Tang, H. Liu, L. Wang, Learning with multi-resolution overlapping communities, Knowl. Inf. Syst. 36 (2013) 517–535. [78] G. Palla, I. J. Farkas, P. Pollner, I. Der´enyi, T. Vicsek, Fundamental statistical features and self-similar properties of tagged networks, New J. Phys. 10 (2008) 123026. [79] L. M. Collins, C. W. Dent, Omega: A general formulation of the rand index of cluster recovery suitable for non-disjoint solutions, Multivari- ate Behavioral Research 23 (1988) 231–242. [80] G. Murray, G. Carenini, R. Ng, Using the omega index for evaluat- ing abstractive community detection, in: Proceedings of Workshop on Evaluation Metrics and System Comparison for Automatic Summa- rization, Association for Computational Linguistics, Stroudsburg, PA, USA, 2012, pp. 10–18. [81] C. Vehlow, T. Reinhardt, D. Weiskopf, Visualizing fuzzy overlapping IEEE Transactions on Visualization and communities in networks, Computer Graphics 19 (2013) 2486–2495. [82] J. Su, T. C. Havens, Fuzzy community detection in social networks using a genetic algortihm, in: 2014 IEEE International Conference on Fuzzy Systems (FUZZ-IEEE), pp. 2039–2046. 53 [83] I. Psorakis, S. Roberts, B. Sheldon, Efficient Bayesian Community Detection using Non-negative Matrix Factorisation (2010). [84] G. B. Davis, K. M. Carley, Clearing the fog: Fuzzy, overlapping groups for social networks., Social Networks 30 (2008) 201–212. [85] E. Hllermeier, M. Rifqi, S. Henzgen, R. Senge, Comparing fuzzy parti- tions: A generalization of the rand index and related measures., IEEE Trans. Fuzzy Systems 20 (2012) 546–556. [86] L. Parsons, E. Haque, H. Liu, Subspace clustering for high dimensional data: A review, SIGKDD Explor. Newsl. 6 (2004) 90–105. [87] L. I. Kuncheva, S. T. Hadjitodorov, Using diversity in cluster en- IEEE International Conference on Systems, Man and sembles, Cybernetics, volume 2, pp. 1214–1219 vol.2. in: [88] S. T. Hadjitodorov, L. I. Kuncheva, L. P. Todorova, Moderate diversity for better cluster ensembles, Inf. Fusion 7 (2006) 264–275. [89] X. Z. Fern, W. Lin, Cluster ensemble selection, Statistical Analysis and Data Mining 1 (2008) 128–141. [90] A. Strehl, J. Ghosh, Cluster ensembles - a knowledge reuse framework for combining multiple partitions, J. Mach. Learn. Res. 3 (2003) 583– 617. [91] J. Li, K. Yi, Q. Zhang, Clustering with Diversity, Springer Berlin Hei- delberg, Berlin, Heidelberg, pp. 188–200. [92] X. Z. Fern, C. E. Brodley, Random projection for high dimensional data in: T. Fawcett, N. Mishra clustering: A cluster ensemble approach., (Eds.), ICML, AAAI Press, 2003, pp. 186–193. [93] X. Z. Fern, W. Lin, Cluster ensemble selection, in: SDM, SIAM, 2008, pp. 787–797. [94] T. Chakraborty, N. Modani, R. Narayanam, S. Nagar, Discern: A diversified citation recommendation system for scientific queries, in: 2015 IEEE 31st International Conference on Data Engineering, pp. 555–566. 54 [95] Q. Mei, J. Guo, D. Radev, Divrank: The interplay of prestige and diversity in information networks, in: Proceedings of the 16th ACM SIGKDD International Conference on Knowledge Discovery and Data Mining, KDD '10, ACM, New York, NY, USA, 2010, pp. 1009–1018. [96] X. Zhang, T. Martin, M. E. J. Newman, Identification of core-periphery structure in networks, Phys. Rev. E 91 (2015) 032803. [97] S. Carmi, S. Havlin, S. Kirkpatrick, Y. Shavitt, E. Shir, From the Cover: A model of Internet topology using k-shell decomposition, PNAS 104 (2007) 11150–11154. [98] C. C. L. K.-z. Y. D.-p. Chen Xiao-qiang, ZHOU Li-hua, Detecting stable communities in dynamic networks, Journal of Chinese Computer Systems 36 (2015) 1977. [99] N. Eagle, A. Pentland, D. Lazer, Inferring Social Network Structure using Mobile Phone Data, PNAS (2007). [100] T. Chakraborty, On the discovery of invariant groups in complex net- works, J. Complex Networks 5 (2017) 734–749. 55
1807.01925
1
1807
2018-07-05T09:59:53
Evaluating the impact of the 2012 Olympic Games policy on the regeneration of East London using spatio-temporal big data
[ "cs.SI" ]
For urban governments, introducing policies has long been adopted as a main approach to instigate regeneration processes, and to promote social mixing and vitality within the city. However, due to the absence of large fine-grained datasets, the effects of these policies have been historically hard to evaluate. In this research, we illustrate how a combination of large-scale datasets, the Index of Deprivation and Foursquare data (an online geo-social network service) could be used to investigate the impact of the 2012 Olympic Games on the regeneration of East London neighbourhoods. We study and quantify both the physical and socio-economic aspects of this, where our empirical findings suggest that the target areas did indeed undergo regeneration after the Olympic project in some ways. In general, the growth rate of Foursquare venue density in Olympic host boroughs is higher than the city's average level since the preparation period of the Games and up to two years after the event. Furthermore, the deprivation levels in East London boroughs also saw improvements in various aspects after the Olympic Games. One negative outcome we notice is that the housing affordability becomes even more of an issue in East London areas with the regeneration gradually unfolding.
cs.SI
cs
Evaluating the impact of the 2012 Olympic Games policy on the regeneration of East London using spatio-temporal big data Xiao Zhou Computer Laboratory Univerisity of Cambridge Desislava Hristova Computer Laboratory Univerisity of Cambridge [email protected] [email protected] Anastasios Noulas Data Science Institute University of Lancaster [email protected] Cecilia Mascolo Computer Laboratory Univerisity of Cambridge [email protected] 8 1 0 2 l u J 5 ] I S . s c [ 1 v 5 2 9 1 0 . 7 0 8 1 : v i X r a Abstract For urban governments, introducing policies has long been adopted as a main approach to instigate regeneration pro- cesses, and to promote social mixing and vitality within the city. However, due to the absence of large fine-grained datasets, the effects of these policies have been histori- cally hard to evaluate. In this research, we illustrate how a combination of large-scale datasets, the Index of Depri- vation and Foursquare data (an online geo-social network service) could be used to investigate the impact of the 2012 Olympic Games on the regeneration of East London neigh- bourhoods. We study and quantify both the physical and socio-economic aspects of this, where our empirical find- ings suggest that the target areas did indeed undergo regen- eration after the Olympic project in some ways. In general, the growth rate of Foursquare venue density in Olympic host boroughs is higher than the city's average level since the preparation period of the Games and up to two years after the event. Furthermore, the deprivation levels in East London boroughs also saw improvements in various as- pects after the Olympic Games. One negative outcome we notice is that the housing affordability becomes even more of an issue in East London areas with the regeneration grad- ually unfolding. Introduction In recent decades, the topic of urban regeneration has re- ceived increasing attention globally, due to the undeniably significant role it may play in city development (Ye, et al., 2015). It is used by governments as a boost to disinvested urban areas, reducing relative levels of deprivation and promoting 'social mixing' (Keddie, 2014). Furthermore, for international metropolises like London, urban regenera- tion can be even more necessary by building attractive ur- ban spaces of business, leisure and residence to promote its functional role in the global economy (Sassen, 2001; Webber, 2007). Realising the positive effects that might be brought with regeneration, the urban government of London has put forward a series of policies to instigate it, so as to counter- balance the continuing post-war exodus from the city cen- tre and draw developers to invest (Keddie, 2014). Among them, the regeneration policies related to 2012 Olympic Games are generally regarded as the most striking ones re- cently. "The Game will be London's single most important regeneration project for the next 25 years", as the Mayor of London indicated. This mega event was expected to orig- inally stimulate the regeneration agenda of six host bor- oughs (Hackney, Tower Hamlets, Newham, Barking and Dagenham, Waltham Forest, and Greenwich) and eventu- ally catalyse the revitalisation of the whole East London. Compared with the rest of the city and the country, East London is one of the most physically fragmented, envi- ronmentally compromised and socially deprived districts which is seen as the greatest remaining regeneration op- portunity in inner London (ODA, 2010). However, the success of regeneration through Olympic Games is not guaranteed. With quite a few challenges lying ahead, long-term efforts and study are required. Firstly, the deprivation of East London is a historical prob- lem that is extremely hard to solve. Even though several waves of regeneration strategies have already been imple- mented in East London, tackling the deprivation of this area is still challenging for many decades (Gavin, 2012; Dmitry, 2012). Some critics suggest that the Olympic strat- egy might be going in the same direction as previous poli- cies in its failure to achieve the regeneration goal (NEF, 2008). Furthermore, the experience of previous Olympic cities shows that the mega events are not necessarily an ef- fective mechanism for catalysing urban development and renewal (Dmitry, 2012). Some Olympic projects turned out to be 'white elephants' only in the years after the event (Galina, 2011; Sue, 2010; Cashman, 2009; Macrury, 2008). Also, to evaluate the impact of regeneration policy is hard in nature due to the lack of data and data-driven ap- proaches. Indeed, from existing evidence, the power of the state to intervene and influence the market through mak- ing policies has been demonstrated. However, what to and how to measure the physical and social regeneration that is induced by policies is still a new area of inquiry for re- searchers to work out (Lees & Melhuish, 2015). Whether or not Olympic regeneration project can be shown to have long-term benefits is still unclear in the existing literature. Fortunately, with the emergence of the Big Data era, an increasingly rich data environment has become available to policy makers to shed new light on the issue. Through the lens of a huge range of data sources, the change of urban places and actual behaviours of citizens have be- come unprecedentedly observable at very fine grain spa- tial and temporal scale, offering the potential to benefit urban study. Some promising results have been presented in existing research using Foursquare data. For instance, Daggitt et al. (2015) analysed urban growth across ma- jor cities worldwide. Karamshuk et al. (2013) studied op- timal retail store placement in the city. In this research, we use the English Indices of Deprivation and Foursquare data to examine how successfully the Olympic regenera- tion policies have worked and question whether the ide- als of promoting local liveability and social-economic de- velopment have been achieved in East London at differ- ent geographic levels. In order to answer this overarching question on whether the policies are effective, the research is structured around the three sub-questions: 1. What the representative Olympic regeneration policies and their goals are; 2. Whether the policies have brought significant changes to various categories of urban places within the target area; 3. How human spatio-temporal mobility pat- terns have been influenced since the policies took place; 4. And whether the deprivation conditions of East London become more or less divergent. Policies From the very beginning, the ambition of bridging the his- torical gap between West and East London has been at the core of the Olympic bid and frequently shown in the sub- sequent related plans (Dmitry, 2012). These plans are led by governments and organisations whose interests range from comprehensive coverage of the Games' impact to a focus on specific geographical and subject areas (DCLG, 2015). In some Olympic legacy plans at region or even country level, the regeneration of East London was put for- ward as one of the major targets. A summary of the key plans and their goals involved in the renewal of East Lon- don are provided in Table 1. Some other policies make their targets more specific by focussing on the regenera- tion of smaller spatial coverage, like the host boroughs or the Olympic Park. The Strategic Regeneration Framework (SRF) is one of the significant plans that contributes to the delivery of this aim and is the main policy that is evaluated in this research. The objective of the SRF is to ensure both of the physical regeneration and socio-economic benefits are brought to the host boroughs. From the physical regeneration side, it aims to create well-designed, successful and sustainable places that attract new business, new mixed communi- ties, and enhance existing neighbourhoods. On the socio- economic part, it holds an ambitious goal to achieve rad- ical socio-economic convergence between host boroughs and the London average for key indicators of deprivation. To meet the convergence objective, seven core outcomes were proposed in the SRF (Table 2). The SRF expects to achieve the goals within a 20-year timeframe from 2010 to 2030. It also includes three interim targets to be met by 2015, which are: narrowing the gap of local satisfaction between London average and the host boroughs; delivering new and better places to live and Plans London Plan (2004) Mayor of London's five legacy promises (2007) The Government's Legacy Action Plan (2008) The Coalition Agreement (2010) Department for Communities and Local Government's (DCLG) Business Plan 2011-2015 (2010) Targets Regenerating East London •Transforming the heart of East London •Transforming the heart of East London •Making the Olymlic Park a blueprint for sustainable living • Ensuring that the Olympic Park can be developed after the Games as one of the principal drivers of regeneration in East London. •Regenerating the Thames Gateway Table 1: Groups of London Wards in ANOVA analyses. work, including homes, the related schools, health cen- tres and other social infrastructure; and completing the early stages of the Olympic Park redevelopment as a last- ing legacy (SRF, 2009). 1 2 3 4 5 6 7 Creating a coherent and high quality city within a world city region Improving educational attainment, skills and raising aspirations Reducing worklessness, benefit dependency and child poverty Homes for all Enhancing health and wellbeing Reducing serious crime rates and anti-social behaviour Maximising the sports legacy and increasing participation Table 2: Seven key outcomes of the SRF Impact Evaluation In this section, the datasets collected for the research are described, followed by how they are analysed to evaluate the physical and socio-economic impact of the Olympic Games on East London (primarily focus on six Olympic host boroughs in this study) at different geographical lev- els. Data Collection Data for the study are drawn from the English Index of De- privation and location-based social network Foursquare. The English Indices of Deprivation is an official measure of relative deprivation for small areas (Lower-layer Super Output Areas) in England calculated by the Department Venue Density We explore how the density of venues changed within host boroughs in total, and compare it with the average level in the whole city. The venue den- sity is calculated by dividing the number of venues within an area by its size. As can be seen from the first subfig- ure of Figure 2, both of the densities in host boroughs and London present a growing trend during the four years. By the end of the study period, the venue density of host bor- oughs in total was almost twice that of its initial value. One noteworthy point is the relative change between the two densities. At the beginning, the venue density of host boroughs was lower than London's average level. Then the gap became increasingly smaller until July 2013, when the values became equal. After that, the average venue den- sity of host boroughs overpassed the city average level by the end of August 2014. In the middle subfigure of Fig- ure 2, the monthly growth rates of venue densities are presented, from which we can see host boroughs have a higher growth rate in general than London's, and two evi- dent peaks show in October 2011 and August 2012, respec- tively. Instead of studying the host boroughs as a whole, the analysis next is to look into the differences on venues' growth between boroughs. As the last subfigure of Fig- ure 2 presents, Hackney and Tower Hamlets are the bor- oughs where the venue densities are far more than the av- erage and other host boroughs. Another striking point is the venue density boost of Newham (where the Olympic Park is located) in October 2011. Venue Composition After understanding how the den- sity of venues has changed, we explore the difference in composition of new venues between a host area and its counterparts. In Figure 3, the colour of each square repre- sents the proportion of venues of that particular category from the total number of new venues within the area in each year. We observe that for both host boroughs and the rest of London, the category of food has the largest per- centage among each year's new venues. However, the pro- portion of food for host boroughs was not as significant as for the rest of London in general. An important com- ponent of new venues in host boroughs is the Outdoors & Recreation category, which always presents the second largest category within the group, and is usually above the proportion for the rest of London. This phenomenon is es- pecially evident during the years of 2010, 2012, and 2014, when the proportion of host boroughs as compared to the rest are 10% to 6%, 6.5% to 3.4%, and 5.9% to 0.76%, re- spectively. Another four categories that the Olympic area shows a greater proportion for are Arts & Entertainment, Professional & Other Places, Nightlife Spots, and Stadi- ums. On the contrary, categories related to transport, like Airports, Train Stations, Travel & Transport are more ex- pressed in the rest of London. Socio-economic Impact Compared with physical legacies, the 'soft' impacts of socio-economic are less apparent, harder to measure, but necessary in the evaluation of Olympic policy's effective- ness. In this section, we try to measure the socio-economic Figure 1: The distribution of the Olympic Park, Host bor- oughs, and Foursquare venues by the end of the study pe- riod for Communities and Local Government. It is organised across seven sub domains of deprivation (Health Depri- vation and Disability; Employment Deprivation; Income Derivation; Education, Skills and Training Deprivation; Crime; Barriers to Housing and Services; and Living En- vironment Deprivation) to produce the Index of Multiple Deprivation (IMD), an overall relative measure of depri- vation. The versions used in this research are 2010 Index and 2015 Index, through a comparative analysis of which, changes of multiple deprivation levels of the study area are tracked to have an insight of the socio-economic im- pact of the policy. Alongside the Index of Deprivation data, we also collected user mobility records and venues' infor- mation in London through a four-year long dataset from June 2010 to August 2014 of Foursquare. This Foursquare data contains all "transitions" (pairs of check-ins by users between two different venues) occurring within London during the study period. For each transition, we have the start time, end time, source venue and destination venue. The information of Foursquare venues in London is also available in our dataset, through which we know the geo- graphic coordinates, category, creation time and the total number of users that have check-in(s) at each venue. Physical Impact To explore whether the policy has significantly influenced the physical regeneration in Olympic host boroughs, we use Foursquare data to identify local urban growth pat- terns by measuring whether there are many venues of certain categories emerging after the policy was imple- mented. Figure 1 shows the location of our research area and the distribution of venues at the end of the study period. In the following analysis, we track the trend of venue growth and category composition by time and dis- cuss how the changes vary by host boroughs using London as benchmark comparator. Figure 2: The comparison of venue density between host boroughs and London average by date impact through studying human mobility features, and an investigation of deprivation changes before and after the Olympic regeneration program. Mobility Features To explore how the volume of transi- tions from and towards an area changes over time may provide us some alternative insights into local vitality. We analyse this in Figure 4 and Figure 5, which display the transition popularities in host boroughs and London in to- tal. We measure the transition popularity through dividing the total number of transitions from and towards an area by its population. We observe that the Olympic host bor- oughs as a whole has lower number of flows than that in London in most cases, with an exception in August 2012, when the Olympic Games took place. This phenomenon is more evident when the analysis is undertaken at borough's level. As we can see from Figure 5, in the major Olympic borough of Newham, the flow transitions peaked during the Olympic period with an incomparable value. However, the average number of transition flows in host boroughs fell dramatically after the mega event, and returned to its normal level in the post-Olympic period. Figure 4: Average number of transition flows in host bor- oughs in total and London Figure 3: The percentage of categories for new venues in each year Figure 5: Average number of transition flows in each host borough and London Deprivation Changes As the SRF's objectives clarified, the primary ambition of Olympic regeneration policy is to eliminate the radical deprivation in East London. To ex- plore whether the deprivation level has changed before and after the Games, we compare IMD2010 and IMD2015 as well as their sub domains of deprivation in health, em- ployment, education, housing, income, crime and living environment. Figure 6 presents the changes in borough ranks on aver- age IMD and sub domain scores for London boroughs be- tween 2010 and 2015, where the positive values mean the deprivation has been reduced while negative ones mean it became worse. From the figure we can tell that the over- all IMD deprivation of East London has been improved in general. To be more precise, Waltham Forest, Newham, Hackney and Greenwich are the four host boroughs whose overall deprivation was reduced between 2010 and 2015. The most significant improvement happened in Green- wich, whose ranking went up by 6 positions from the 8th most deprived borough to 14th in London. However, Bark- ing and Dagenham, and Tower Hamlets unfortunately be- came relatively more deprived in 2015 compared with 2010. When focusing on the changes in sub domains, it can be found that the deprivation in most domains has been improved. We determine the overall deprivation level re- duced in the study area when the average of rank change for all host boroughs is positive. Under such a rule, we can see that income, employment, education, health, crime and living environment dimensions of deprivation have all improved. However, the deprivation in terms of Barri- ers to housing and services domain became greater within five of the six host boroughs. This outcome suggests that it has become harder for residents to find affordable housing in the Olympic boroughs after the Games. Discussion and Conclusion Through the analyses above, some positive results are for- tunately discovered, suggesting that regeneration indeed Figure 6: Changes in rankings of deprivation for host bor- oughs between 2010 and 2015 happened within East London to some degree. To evalu- ate the effectiveness of Olympic regeneration project by reference to the objectives in the SRF, we observe that the physical regeneration goal has been at least partly achieved as an increasing number of new businesses have been attracted to East London by a growth rate higher than London's average. The composition of these new venues is very diverse among which, food, nightlife spots, recreation, arts and entertainment categories are the main contributors. From a socio-economic perspective, the host boroughs of Waltham Forest, Newham, Hackney and Greenwich generally saw significant improvements in key indicators of deprivation, including income, employment, education, health, and living environment. Barriers to housing and services is the only deprivation indicator that became even worse after the Games. This finding indicates that the target of 'home for all' may fail to be met and re- minds policy makers to pay more attention to the social problems coming along with the regeneration, such as the displacement of poorer local residents. When looking at the performance of each host borough, Newham, the main site of the Games, excels in venue den- sity and transition flows growth during the Olympic pe- riod. In contrast, Barking and Dagenham, the youngest official host borough, who joined the Olympic project in April, 2011, performed worst in both physical and socioe- conomic regeneration. This may be attributed to the fact that the study period in this research is too close to the time it became a member. Follow-up analysis would be needed to evaluate its long-term regeneration success as well as other boroughs within East London as a whole. The datasets used and results concluded in this research are certainly not free of biases and limitations. The data on venues registered in Foursquare is not the absolute venue set in London, however, it does exhibit successfully pat- terns of change during the study period. It would also be improper to state that everything that is happening in East London is occurring because of the 2012 Olympics. How- ever, it might be no exaggeration to say that regenera- tion did happen within the area of East London between 2010 and 2015, which coincides with the Olympic policy. The analysis presented in this work opens the door to us- ing spatio-temporal big data to evaluate government's re- generation policy from a dynamic view, and provides ev- idence and implications for further related policymaking processes. Acknowledgements We acknowledge the support from the Cambridge Trust, the China Scholarship Council, and Foursquare. University. SRF (2009). Strategic regeneration framework: an Olympic legacy for the host boroughs. Sassen, S. (2001). The Global City: New York, London, Tokyo, Princeton: University Press. Webber, R. (2007) The metropolitan habitus: its manifes- tations, locations and consumption profiles. Environment and Planning A, 39, 182-207. Ye, M., Vojnovic, I., & Chen, G. (2015). The landscape of gentrification: exploring the diversity of "upgrading" processes in Hong Kong, 1986–2006. Urban Geography, 36(4), 471-503. References Cashman, R. (2009). Regenerating Sydney's West: framing and adapting an Olympic vision, in Poynter, G. and MacRury, I. (eds.) Olympic Cities: 2012 and the Remaking of London. Farnham: Ashgate, 130-143. DCLG (2015). London 2012 Olympics: regeneration legacy evaluation framework. Daggitt, M. L., Noulas, A, Shaw, B., & Mascolo, C. (2015). Tracking urban activity growth globally with big location data. Royal Society open science, 3(4), 150688. Dmitry, S. (2012). A marathon not a sprint? Legacy lessons for London. Centre for Cities. Galina, G. (2011). The Olympics' employment and skills legacy: a literature review. Work and Employment Re- search Unit, University of Greenwich. Gavin, P. (2012). Mega events and the urban econ- omy: what can Olympic cities learn from each other? http://olympicstudies.uab.es/lectures/web/pdf/Poynter_ eng.pdf Karamshuk, D., Noulas, A., Scellato, S., Nicosia, V, & Mascolo, C. (2013). Geo-spotting: mining online location- based services store placement. Proceedings of the 19th ACM SIGKDD international conference on Knowledge discovery and data mining, August 11-14, Chicago, Illinois, USA. Keddie, J. (2014). Negotiating urban change in gentrifying London: Experiences of long-term residents and early gentrifiers in Bermondsey (PhD thesis). Lees, l. & Clare, M. (2015). Arts-led regeneration in the UK: the rhetoric and the evidence on urban social inclusion. European Urban and Regional Studies, 22(3), 242-260. Macrury, I. (2008). Re-thinking the legacy 2012: the Olympics as commodity and gift. Twenty-First Century Society, 3(3), 297-312 NEF (2008). Fools gold. Community Links. ODA (2010). The Olympic Park: towards a 10 year land- scape management & maintenance plan. Sue, B. (2010). Literature review: Olympic venues- regeneration legacy London assembly. Oxford Brookes for optimal retail
1806.08468
1
1806
2018-06-22T02:16:14
Personalized Thread Recommendation for MOOC Discussion Forums
[ "cs.SI", "cs.CY", "stat.AP" ]
Social learning, i.e., students learning from each other through social interactions, has the potential to significantly scale up instruction in online education. In many cases, such as in massive open online courses (MOOCs), social learning is facilitated through discussion forums hosted by course providers. In this paper, we propose a probabilistic model for the process of learners posting on such forums, using point processes. Different from existing works, our method integrates topic modeling of the post text, timescale modeling of the decay in post activity over time, and learner topic interest modeling into a single model, and infers this information from user data. Our method also varies the excitation levels induced by posts according to the thread structure, to reflect typical notification settings in discussion forums. We experimentally validate the proposed model on three real-world MOOC datasets, with the largest one containing up to 6,000 learners making 40,000 posts in 5,000 threads. Results show that our model excels at thread recommendation, achieving significant improvement over a number of baselines, thus showing promise of being able to direct learners to threads that they are interested in more efficiently. Moreover, we demonstrate analytics that our model parameters can provide, such as the timescales of different topic categories in a course.
cs.SI
cs
Personalized Thread Recommendation for MOOC Discussion Forums Andrew S. Lan Princeton University [email protected] Jonathan C. Spencer Princeton University [email protected] Ziqi Chen HKUST [email protected] Christopher G. Brinton Zoomi Inc. [email protected] 8 1 0 2 n u J 2 2 ] I S . s c [ 1 v 8 6 4 8 0 . 6 0 8 1 : v i X r a ABSTRACT Social learning, i.e., students learning from each other through social interactions, has the potential to significantly scale up in- struction in online education. In many cases, such as in massive open online courses (MOOCs), social learning is facilitated through discussion forums hosted by course providers. In this paper, we propose a probabilistic model for the process of learners posting on such forums, using point processes. Different from existing works, our method integrates topic modeling of the post text, timescale modeling of the decay in post activity over time, and learner topic interest modeling into a single model, and infers this information from user data. Our method also varies the excitation levels induced by posts according to the thread structure, to reflect typical notifi- cation settings in discussion forums. We experimentally validate the proposed model on three real-world MOOC datasets, with the largest one containing up to 6,000 learners making 40,000 posts in 5,000 threads. Results show that our model excels at thread recom- mendation, achieving significant improvement over a number of baselines, thus showing promise of being able to direct learners to threads that they are interested in more efficiently. Moreover, we demonstrate analytics that our model parameters can provide, such as the timescales of different topic categories in a course. 1 INTRODUCTION Online discussion forums have gained substantial traction over the past decade, and are now a significant avenue of knowledge shar- ing on the Internet. Attracting learners with diverse interests and backgrounds, some platforms (e.g., Stack Overflow, MathOverflow) target specific technical subjects, while others (e.g., Quora, Reddit) cover a wide range of topics from politics to entertainment. More recently, discussion forums have become a significant com- ponent of online education, enabling students in online courses to learn socially as a supplement to their studying of the course content individually [2]; social interactions between learners have been seen to improve learning outcomes [4]. In particular, mas- sive open online courses (MOOCs) often have tens of thousands of learners within single sessions, making the social interactions via these forums critical to scaling up instruction [3]. In addition to serving as a versatile complement to self-regulated learning [23], research has shown that learner participation on forums can be predictive of learning outcomes [25]. In this paper, we ask: How can we model the activity of individ- ual learners in MOOC discussion forums? Such a model, designed correctly, presents several opportunities to optimize the learning Mung Chiang Purdue University [email protected] process, including personalized news feeds to help learners sort through forum content efficiently, and analytics on factors driving participation. 1.1 Prior work on discussion forums Generic online discussion sites. There is vast literature on ana- lyzing user interactions in online social networks (e.g., on Face- book, Google+, and Twitter). Researchers have developed methods for tasks including link prediction [10, 16], tweet cascade analy- sis [7, 22], post topic analysis [20], and latent network structure estimation [13, 14]. These methods are not directly applicable to modeling MOOC discussion forums since MOOCs do not support an inherent social structure; learners cannot become "friends" or "follow" one another. Generic online discussion forums (e.g., Stack Overflow, Quora) have also generated substantial research. Researchers have devel- oped methods for tasks including question-answer pair extraction [5], topic dynamics analysis [26], post structure analysis [24], and user grouping [21]. While these types of forums also lack explicit social structure, MOOC discussion forums exhibit several unique characteristics that need to be accounted for. First, topics in MOOC discussion forums are mostly centered around course content, as- signments, and course logistics [3], making them far more struc- tured than generic forums; thus, topic modeling can be used to organize threads and predict future activity. Second, there are no sub-forums in MOOCs: learners all post in the same venue even though their interests in the course vary. Modeling individual in- terest levels on each topic can thus assist learners in navigating through posts. MOOC forums. A few studies on MOOC discussion forums have emerged recently. The works in [18, 19] extracted forum structure and post sentiment information by combining unsupervised topic models with sets of expert-specified course keywords. In this work, our objective is to model learners' forum behavior, which requires analyzing not only the content of posts but also individual learner interests and temporal dynamics of the posts. In terms of learner modeling, the work in [8] employed Bayesian nonnegative matrix factorization to group learners into communi- ties according to their posting behavior. This work relies on topic labels of each discussion post, though, which are either not avail- able or not reliable in most MOOC forums. The work in [2] inferred learners' topic-specific seeking and disseminating tendencies on forums to quantify the efficiency of social learning networks. How- ever, this work relies on separate models for learners and topics, whereas we propose a unified model. The work in [9] couples social network analysis and association rule mining for thread recommen- dation; while their approach considers social interactions among learners, they ignore the content and timing of posts. As for modeling temporal dynamics, the work in [3] proposed a method that classifies threads into different categories (e.g., small- talk, course-specific) and ranks thread relevance for learners over time. This model falls short of making recommendations, though, since it does not consider learners individually. The work in [27] employed matrix factorization for thread recommendation and studied the effect of window size, i.e., recommending only threads with posts in a recent time window. However, this model uses temporal information only in post-processing, which limits the insights it offers. The work in [15] focuses on learner thread viewing rather than posting behavior, which is different from our study of social interactions since learners view threads independently. The model proposed in [17] is perhaps most similar to ours, as it uses point processes to analyze discussion forum posts and associates different timescales with different types of posts to reflect recurring user behavior. With the task of predicting which Reddit sub-forum a user will post in next, the authors base their point processes model on self-excitations, as such behavior is mostly driven by a user's own posting history. Our task, on the contrary, is to recommend threads to learners taking a particular online course: here, excitations induced by other learners (e.g., explicit replies) can significantly affect a learner's posting behavior. As a result, the model we develop incorporates mutual excitation. Moreover, [17] labels each post based on the Reddit sub-forum it belongs to; no such sub-forums exist in MOOCs. 1.2 Our model and contributions In this paper, we propose and experimentally validate a probabilistic model for learners posting on MOOC discussion forums. Our main contributions are as follows. First, through point processes, our model captures several impor- tant factors that influence a learner's decision to post. In particular, it models the probability that a learner makes a post in a thread at a particular point in time based on four key factors: (i) the interest level of the learner on the topic of the thread, (ii) the timescale of the thread topic (which corresponds to how fast the excitation induced by new posts on the topic decay over time), (iii) the timing of the previous posts in the thread, and (iv) the nature of the previ- ous posts regarding this learner (e.g., whether they explicitly reply to the learner). Through evaluation on three real-world datasets- the largest having more than 6,000 learners making more than 40,000 posts in more than 5,000 threads-we show that our model significantly outperforms several baselines in terms of thread rec- ommendation, thus showing promise of being able to direct learners to threads they are interested in. Second, we derive a Gibbs sampling parameter inference algo- rithm for our model. While existing work has relied on thread labels to identify forum topics, such metadata is usually not available for MOOC forum threads. As a result, we jointly analyze the post times- tamp information and the text of the thread by coupling the point process model with a topic model, enabling us to learn the topics and other latent variables through a single procedure. Third, we demonstrate several types of analytics that our model parameters can provide, using our datasets as examples. These include: (i) identifying the timescales (measured as half-lives) of different topics, from which we find that course logistics-related topics have the longest-lasting excitations, (ii) showing that learners are much (20-30 times) more likely to post again in threads they have already posted in, and (iii) showing that learners receiving explicit replies in threads are much (300-500 times) more likely to post again in these threads to respond to these replies. 2 POINT PROCESSES FORUM MODEL An online course discussion forum is generally comprised of a series of threads, with each thread containing a sequence of posts and comments on posts. Each post/comment contains a body of text, written by a particular learner at a particular point in time. A thread can further be associated with a topic, based on analysis of the text written in the thread. Figure 1 (top) shows an example of a thread in a MOOC consisting of eight posts and comments. Moving forward, the terminology "posting in a thread" will refer to a learner writing either a post or a comment. We postulate that a learner's decision to post in a thread at a certain point in time is driven by four main factors: (i) the learner's interest in the thread's topic, (ii) the timescale of the thread's topic, (iii) the number and timing of previous posts in the thread, and (iv) the learner's prior activity in the thread (e.g., whether there are posts that explicitly reply to the learner). The first factor is consistent with the fact that MOOC forums generally have no sub-forums: in the presence of diverse threads, learners are most likely to post in those covering topics they are interested in. The second factor reflects the observation that different topics exhibit different patterns of temporal dynamics. The third factor captures the common options for thread-ranking that online forums provide to users, e.g., by popularity or recency; learners are more likely to visit those at the top of these rankings. The fourth factor captures the common setup of notifications in discussion forums: learners are typically subscribed to threads automatically once they post in them, and notified of any new posts (especially those that explicitly reply to them) in these threads. To capture these dynamics, we model learners' posts in threads as events in temporal point processes [6], which will be described next. Point processes. A point process, the discretization of a Poisson process, is characterized by a rate function λ(t) that models the probability that an event will happen in an infinitesimal time win- dow dt [6]. Formally, the rate function at time t is given by N(t + dt) − N(t) λ(t) = P(event in [t, t + dt)) = lim dt→0 (1) where N(t) denotes the number of events up to time t [6]. Assuming the time period of interest is [0,T), the likelihood of a series of events at times t1, . . . , tN < T is given by: dt , (cid:32) N i =1 (cid:33) −∫ T 0 λ(τ)dτ . L({ti}N i =1) = λ(ti) e (2) In this paper, we are interested in rate functions that are affected by excitations of past events (e.g., forum posts in the same thread). Thus, we resort to Hawkes processes [17], which characterize the 2 rate function at time t given a series of past events at t1, . . . , tN ′ < t as N ′ i =1 λ(t) = µ + a κ(t − ti), where µ ≥ 0 denotes the constant background rate, a ≥ 0 denotes the amount of excitation each event induces, i.e., the increase in the rate function after an event,1 and κ(·) : R+ → [0, 1] denotes a non- increasing decay kernel that controls the decay in the excitation of past events over time. In this paper, we use the standard exponential decay kernel κ(t) = e−γ t , where γ denotes the decay rate. Through our model, different decay rates can be associated with different topics [17]; as we will see, this model choice enables us to categorize posts into groups (e.g., course content-related, small talk, or course logistics) based on their timescales, which leads to better model analytics. Rate function for new posts. Let U , K, and R denote the number of learners, topics, and threads in a discussion forum, indexed by u, k, and r, respectively. We assume that each thread r functions independently, and that each learner's activities in each thread and on each topic are independent. Further, let zr denote the topic of thread r, and let Pr denote the total number of posts in the thread, indexed by p; for each post p, we use ur p to denote the learner i (u) to denote the ith post index and time of the post, and we use pr of learner u in thread r. Note that posts in a thread are indexed in chronological order, i.e., p < p′ if and only if tr p′. Finally, let γk ≥ 0 denote the decay rate of each topic and let au,k denote the interest level of learner u on topic k. We model the rate function that characterizes learner u posting in thread r (on topic zr = k) at time t given all previous posts in the thread (i.e., posts with tr p < t) as p and tr p < tr u,k(t) = λr au,k p e au,k +α au,k +βα au,k p:p <pr   if t < tr 1 (u) pr p) −γk(t−t r −γk(t−t r p) 1 (u) e −γk(t−t r p) p:p≥pr 1 (u),u(cid:60)d r p e −γk(t−t r p) if t ≥ tr p:u∈d r 1 (u). p e pr (3)    In our model, au,k characterizes the base level of excitation that learner u receives from posts in threads on topic k, which captures the different interest levels of learners on different topics. The exponential decay kernel models a topic-specific decay in excitation of rate γk from the time of the post. Before tr 1 (u) (the timestamp of the first post learner u makes in pr thread r), learner u's rate is given solely by the number and recency 1 (u) = ∞ if the learner never posts in this thread), of posts in r (tr pr while all posts occurring after tr 1 (u) induce additional excitation pr characterized by the scalar variable α. This model choice captures the common setup in MOOC forums that learners are automati- cally subscribed to threads after they post in them. Therefore, we postulate that α > 1, since new post notifications that come with thread subscriptions tend to increase a learner's chance of viewing these new posts, in turn increasing their likelihood of posting again in these threads. The observation of users posting immediately 1a is sometimes referred to in literature as the impulse response [13]. Figure 1: An example of how threads are structured in MOOC discussion forums (top) and an illustration of cor- responding rate functions (bottom) for two learners in this thread. Different posts induce different amounts of exci- tation depending on whether and how they refer to the learner. after receiving notifications is sometimes referred to as the "bursty" nature of posts on social media [7]. We further separate posts made after tr 1 (u) by whether or not pr they constitute explicit replies to learner u. A post p′ is considered to be an explicit reply to a post p in the same thread r if tr p and one of the following conditions is met: (i) p′ makes direct reference (e.g., through name or the @ symbol) to the learner who made post p, or (ii) p′ is the first comment under p.2 dr p in (3) denotes the set of explicit recipients of p, i.e., if p is an explicit reply to learner u, then u ∈ dr p, while if p is not an explicit reply to any learners then p = ∅. This setup captures the common case of learners being dr 2In this work, we restrict ourselves to these two concrete types of explicit replies; analyzing other, more ambiguous types is left for future work. p′ > tr 3 Post 1Get started on machine learning!!!BobAug 21, 201710:55amHow can I prepare for this course? I have ZERO background :PPost 2AnneAug 21, 201711:00amYou can start on the math, like basic statistics and linear algebra.Comment 1JohnAug 21, 201711:03amI'd say trying out the programming tools is more urgent.Comment 2AnonymousAug 21, 201711:05amDitto!Comment 3AnneAug 21, 201711:10am@John Yes, but math is key too. Without it you won't understand a single thing in this course.Comment 4JohnAug 21, 201711:12am@Anne Right, you do need both.Post 3LilyAug 21, 201711:20amI know all these. Can't wait to get started on the course!Post 4BobAug 21, 201711:25amThanks, everyone! I'll get started ASAP. Good luck to y'allInitial excitationNotification excitationExplicit reply excitation notified of posts that explicitly reply to them in a thread. The scalar β characterizes the additional excitation these replies induce; we postulate that β > 1, i.e., the personal nature of explicit replies to learners' posts tends to further increase the likelihood of them posting again in the thread (e.g., to address these explicit replies). Rate function for initial posts. We must also model the process of generating the initial posts in threads. We characterize the rate function of these posts as time-invariant: u,k(t) = µu,k , λr (4) where µu,k denotes the background posting rate of learner u on topic k. Separating the initial posts in threads from future posts in this way enables us to model learners' knowledge seeking (i.e., starting threads) and knowledge disseminating (i.e., posting re- sponses in threads) behavior [2], through the background (µu,k) and excitation levels (au,k), respectively. Post text modeling. Finally, we must also model the text of each thread. Given the topic zr = k of thread r, we model Wr -the bag- of-words representation of the text in r across all posts-as being generated from the standard latent Dirichlet allocation (LDA) model [1], with topic-word distributions parameterized by ϕk. Details on the LDA model and the posterior inference step for ϕk via collapsed Gibbs sampling in our parameter inference algorithm are omitted for simplicity of exposition. Model intuition. Intuitively, a learner will browse existing threads in the discussion forum when they are interested in a particular topic. If a relevant thread exists, they may make their first post there (e.g., Comment 1 by John under Post 2, in Figure 1), with the rate at which this occurs being governed by the previous activity in the thread (posts at times tr p < t) and the learner's interest level in the topic of the thread (au,k). Together with the exponential decay kernel, this model setting reflects the observation that discussion forum threads are often sorted by recency (the time of last post) and popularity (typically quantified by the number of replies). Addition- ally or alternatively, if no such thread exists, the learner may decide to start a new thread on the topic (e.g., Post 1 by Bob), depending on their background rate (µu,k). Once the learner has posted in a thread, they will receive notifications of new posts there (e.g., Lily will be notified of Post 4), which induces higher levels of excitation (α > 1); the personal nature of explicit replies to their posts (e.g., Anne's mention of John in Comment 3 under Post 2) will induce even higher levels of excitation (β > 1). 3 PARAMETER INFERENCE We now derive the parameter inference algorithm for our model. We perform inference using Gibbs sampling, i.e., iteratively sampling from the posterior distributions of each latent variable, conditioned on the other latent variables. The detailed steps are as follows: 1. Sample zr . To sample from the posterior distribution of the topic of each thread, zr , we put a uniform prior over each topic and arrive at the posterior P(zr = k . . .) ∝ P(Wr zr) P({tr′ 1 }r′:zr′ =k′,ur 1 =ur′ 1 µur 1 ,k′) · k′ · u P({tr p}p:ur p =u au,k , α, β, γk), where . . . denotes all variables except zr . P(Wrzr) denotes the likelihood of observing the text of thread r given its topic. P({tr′ 1 ,k′) denotes the likelihood of observing the sequence of initial thread posts on topic k′ made by the learner who also made the initial post in thread r;3 this is given by substituting (4) into (2) as 1 }r′:zr′ =k′,ur 1 =ur′ µur 1 P({tr′  1 }r′:zr′ =k′,ur µur 1 ,k′) 1 =ur′ 1 ,zr′ =k′ 1 =ur′ 1 r′ 1ur 1 ,k′ ur −µur 1 ,k′T · e = µ (5) where 1x denotes the indicator function that takes the value 1 when condition x holds and 0 otherwise. P({tr p}p:ur p =u au,k , α, β, γk) denotes the likelihood of observing the se- quence of posts made by learner u in thread r,4 given by , P({tr p}p:ur p =u au,k , α, β, γk)  p:ur p =u =(cid:169)(cid:173)(cid:173)(cid:171) (cid:18) e p)(cid:170)(cid:174)(cid:174)(cid:172) u,zr (tr λr −∫ T u,zr (t)dt 0 λr (cid:19) , (6) where the rate function λr topic k) is given by (3). u,k(t) for learner u in thread r (with 2. Sample γk. There is no conjugate prior distribution for the ex- citation decay rate variable γk. Therefore, we resort to a pre-defined set of decay rates γk ∈ {γs}S s =1. We put a uni- form prior on γk over values in this set, and arrive at the posterior given by P(γk = γs . . .) ∝   P({tr p}p:ur p =u au,k , α, β, γs). r:zr =k u 3. Sample µu,k. The conjugate prior of the learner background topic interest level variable µu,k is the Gamma distribution. Therefore, we put a prior on µu,k as µu,k ∼ Gam(αµ , βµ) and arrive at the posterior distribution ′ ′ µ) µ , β P(µu,k . . .) ∝ Gam(α µ = αµ + where ′ α r 1ur 1 =u,zr =k , ′ µ = βµ + T . β 4. Sample au,k, α, and β. The latent variables α and β have no con- jugate priors. As a result, we introduce an auxiliary latent variable [13, 22] er p′ = p means that post p is the "parent" of post p′ in thread r, i.e., post p′ was caused by the excitation that the previous post p induced. We first sample the parent variable for each post p according to p for each post p, where er P(er −γzr (t r p′ = p) ∝ ar(p, p ′)e p′,zr , αaur p′−t r p) where ar(p, p′) ∈ {aur p′,zr } depending on the relationship between posts p and p′ from our model, i.e., whether p′ is the first post of up′ in the thread, and if not, whether p is an explicit reply to up′. In general, the set p′,zr , βαaur , 1 is not the initial poster in any thread r′ with zr′ = k′, then {t r′ 3If µr 4If u has not posted in r , then {t r p } = ∅. 1 } = ∅. 4  p=1) = of possible parents of p is all prior posts 1, . . . , p − 1 in r, but in practice, we make use of the structure of each thread to narrow down the set of possible parents for some posts.5 With these parent variables, we can write L({tr p =u), the likelihood of the series of posts learner u makes in thread r as p}p:ur L({tr p =u), p}p:ur L({tr p}p:ur p}Pr r where L({tr p =u) denotes the likelihood of the series of posts learner u makes in thread r. We can then expand the likelihood using the parent variables as L({tr −γzr (T−t r p )) − au,zr γzr (1−e L = p =u) =   p}ur p:p <pr 1 (u) −γzr (t r u e r p′−t r au,zr e p′ =p ·  p:p≥pr 1 (u),u(cid:60)d r p − α au,zr γzr e (1−e −γzr (T−t r p )) p)(cid:170)(cid:174)(cid:174)(cid:172) p)(cid:170)(cid:174)(cid:174)(cid:172) p)(cid:170)(cid:174)(cid:174)(cid:172) . p′ =p p′:ur p′:ur p′:ur p′ =u,e r p′ =u,e r p′ =u,e r   (cid:169)(cid:173)(cid:173)(cid:171) (cid:169)(cid:173)(cid:173)(cid:171) (cid:169)(cid:173)(cid:173)(cid:171) a = αa +  a = βa +  +  +   α = αα +  α = βα + α , β′ p:p≥pr p:u∈d r α β p ′ ′ ′ ′ r p α β We now see that Gamma distributions are conjugate priors for au,k, α, and β. Specifically, if au,k ∼ Gam(αa, βa), its posterior is given by P(au,k . . .) ∼ Gam(α′ a) where a, β′ −γzr (t r p′−t r αau,zr e − β α au,zr γzr e (1−e −γzr (T−t r p )) p′ =p ·  p:u∈d r p −γzr (t r p′−t r βαau,zr e  (cid:16)  1ur p p =u , r:zr =k (1 − e 1 γk 1 (u) −γk(T−t r p)) (1 − e r:zr =k p:p <pr α γk 1 (u),u(cid:60)d r −γk(T−t r (1 − e βα γk p))(cid:17) p . −γk(T−t r p)) Similarly, if α ∼ Gam(αα , βα), the posterior is P(α . . .) ∼ Gam(α′ α) where  (cid:16)  p′ p′ =p,p≥pr 1e r 1 (ur r u p:p≥pr 1 (u),u(cid:60)d r p p′), au,zr γzr (1 − e −γzr (T−t r p)) Learners Weeks Dataset Threads 5,310 1,323 4,860 ml algo comp 15 9 14 Table 1: Basic statistics on the datasets. 6,604 1,833 3,060 Posts 40,050 9,274 17,562 Finally, if β ∼ Gam(αβ , ββ), the posterior is P(β . . .) ∼ Gam(α′ p))(cid:17) −γzr (T−t r . (1 − e p γzr βau,zr p:u∈d r +  = αβ + = ββ + β , β′ ′ β α β r ′ β   β) where   p′ p 1e r p′ =p,ur αau,zr p′ ∈d r p , (1 − e −γzr (T−t r p)). r u p:u∈d r p γzr We iterate the sampling steps 1–4 above after randomly initializ- ing the latent variables according to their prior distributions. After a burn-in period, we take samples from the posterior distribution of each variable over multiple iterations, and use the average of these samples as its estimate. 4 EXPERIMENTS In this section, we experimentally validate our proposed model using three real-world MOOC discussion forum datasets. In par- ticular, we first show that our model obtains substantial gains in thread recommendation performance over several baselines. Subse- quently, we demonstrate the analytics on forum content and learner behavior that our model offers. 4.1 Datasets We obtained three discussion forum datasets from 2012 offerings of MOOCs on Coursera: Machine Learning (ml), Algorithms, Part I (algo), and English Composition I (comp). The number of threads, posts and learners appearing in the forums, and the duration (the number of weeks with non-zero discussion forum activity) of the courses are given in Table 1. Prior to experimentation, we perform a series of pre-processing steps. First, we prepare the text for topic modeling by (i) removing non-ascii characters, url links, punctuations and words that contain digits, (ii) converting nouns and verbs to base forms, (iii) removing stopwords,6 and (iv) removing words that appear fewer than 10 times or in more than 10% of threads. Second, we extract the follow- ing information for each post: (i) the ID of the learner who made the post (ur p), and (iii) the set of learners it explicitly replies to as defined in the model (dr p). For u,k(t)) posts made anonymously, we do not include rates for them (λr when computing the likelihood of a thread, but we do include them as sources of excitation for non-anonymous learners in the thread. p), (ii) the timestamp of the post (tr 5For example, in Fig. 1, Post 2 is the only possible parent post of Comment 1 below, as Comment 1 is an explicit reply to Post 2. We omit the details of this step for simplicity of exposition. 6We use the stopword list in the Python natural language toolkit (http://www.nltk.org/) that covers 15 languages. 5 (a) ml (b) algo (c) comp Figure 2: Plot of recommendation performance over different lengths of the training time window T1 on all datasets. Our model significantly outperforms every baseline. while in the third experiment, we fix the length of the training and testing intervals to 7 weeks and 1 week, respectively, and vary the number of latent topics as K ∈ {2, 3, . . . , 10, 12, 15, 20}. For training, we set the values of the hyperparameters to αa = αµ = 10−4, and βa = βµ = αα = βα = αβ = ββ = 1. We set the pre-defined decay rates {γs}S s =1 to correspond to half-lives (i.e., the time for the excitation of a post to decay to half of its original value) ranging from minutes to weeks. We run the inference algorithm for a total of 200 iterations, with 100 of these being burn-in iterations.7 Baselines. We compare the performance of our point process model (PPS) against four baselines: (i) Popularity (PPL), which ranks threads from most to least popular based on the total number of posts in each thread during the training time interval; (ii) Recency (REC), which ranks threads from newest to oldest based on the timestamp of their most recent post; (iii) Social influence (SOC), a variant of our PPS model that replaces learner topic interest levels with learner social influences (the "Hwk" baseline in [7]); and (iv) Adaptive matrix factorization (AMF), our implementation of the matrix factorization-based algorithm proposed in [27]. To rank threads in our model for each learner, we calculate the probability that learner u will reply to thread r during the testing time interval as P(u posts in r zr = k) P(zr = k) −∫ T2 T1 u,k(t)dt(cid:17) λr The rate function λr u,k(t) is given by (3). P(zr = k) is given by k P(u posts in r) = (cid:16) = · P(zr = k) ∝ P(zr = k ur P({tr 1 − e k u P(zr = k). 1) P(Wr zr = k) p}p:ur p =u,t r p <T1 zr = k), where the likelihoods of the initial post and other posts are given by (2) and (5), and the thread text likelihood P(Wrzr = k) is given by the standard LDA model. The threads are then ranked from highest to lowest posting probability. 7We observe that the Markov chain achieves reasonable mixing after about 50 iterations. 6 Figure 3: Recommendation performance of the algorithms for varying testing window length ∆T on the algo dataset. The point process-based algorithms have highest perfor- mance and are more robust to ∆T . 4.2 Thread recommendation Experimental setup. We now test the performance of our model on personalized thread recommendation. We run three different experiments, splitting the dataset based on the time of each post. The training set includes only threads initiated during the time 1 ∈ [0,T1)}, and only posts on those interval [0,T1), i.e., {r : tr threads made before T1, i.e., {p : tr p ≤ T1}. The test set contains posts made in time interval [T1,T2), i.e., {p : tr p ∈ [T1,T2)}, but excludes new threads initiated during the test interval. In the first experiment, we hold the length of the testing interval fixed to 1 day, i.e., ∆T = T2 − T1 = 1 day, and vary the length of the training interval as T1 ∈ {1 week, . . . ,W − 1 weeks}, where W denotes the number of weeks that the discussion forum stays active. We set W to 10, 8, and 8 for ml, comp, and algo, respectively, to ensure the number of posts in the testing set is large enough. These numbers are less than those in Table 1 since learners drop out during the course, which leads to decreasing forum activity. In the second experiment, we hold the length of the training interval fixed at W − 1 weeks and vary the length of the testing interval as ∆T ∈ {1 day, . . . , 7 days}. In the first two experiments, we fix K = 5, Figure 4: Plot of recommendation performance of our model over the number of topics K on the ml dataset. The best per- formance is obtained at K ≈ 5, though performance is stable for K ≤ 10. Figure 5: Direct comparison of our model against the AMF and PPL baselines using the experimental setup in [27] on the comp dataset. Our model again significantly outperforms both baselines. Evaluation metric. We evaluate recommendation performance using the standard mean average precision for top-N recommenda- tion (MAP@N) metric. This metric is defined by taking the mean (over all learners who posted during the testing time interval) of the average precision N n=1 APu@N = , Pu@n · 1u posted in thread ru(n) min{Ru, N} where Ru denotes the set of threads learner u posted in during the testing time interval [T1,T2), ru(n) denotes the nth thread rec- ommended to the learner, Pu@n denotes the precision at n, i.e., the fraction of threads among the top n recommendations that the learner actually posted in. We use N = 5 in the first two experi- ments, and vary N ∈ {3, 5, 10} in the third experiment. Results and discussion. Fig. 2 plots the recommendation perfor- mance of our model and the baselines over different lengths of the training time window T1 for each dataset. Overall, we see that our model significantly outperforms the baselines in each case, achiev- ing 15%-400% improvement over the strongest baseline.8 The fact that PPS outperforms the SOC baseline confirms our hypothesis that in MOOC forums, learner topic preference is a stronger dri- ver of posting behavior than social influence, consistent with the fact that most forums do not have an explicit social network (e.g., of friends or followers). The fact that PPS outperforms the AMF baseline emphasizes the benefit of the temporal element of point processes in capturing the dynamics in thread activities over time, compared to the (mostly) static matrix factorization-based algo- rithms. Note also that as the amount of training data increases in the first several weeks, the recommendation performance tends to increase for the point processes-based algorithms while decreasing for PPL and REC. The observed fluctuations can be explained by the decreasing numbers of learners in the test sets as courses progress, since they tend to drop out before the end (see also Fig. 6). Fig. 3 plots the recommendation performance over different lengths of the testing time window ∆T for the algo dataset. As 8Note that these findings are consistent across each dataset. Moving forward, we present one dataset in each experiment unless differences are noteworthy. 7 in Fig. 2, our model significantly outperforms every baseline. We also see that recommendation performance tends to decrease as the length of the testing time window increases, but while the perfor- mance of point process-based algorithms decay only slightly, the performance of the PPL and AMF baselines decrease significantly (by around 50%). This observation suggests that our model excels at modeling long-term learner posting behavior. Finally, Fig. 4 plots the recommendation performance of the PPS model over different numbers of topics K for the ml dataset, for different choices of N , T1 and ∆T . In each case, the performance rises slightly up to K ≈ 5 and then drops for larger values (when overfitting occurs). Overall, the performance is relatively robust to K, for K ≤ 10. 4.3 Direct comparison with AMF The MAP@5 values we obtained for both the AMF and PPL base- lines are significantly less than those reported in [27], where AMF is proposed. To investigate this, we also perform a direct, head-to- head comparison between our model and these baselines under our closest possible replication of the experimental setting in [27]. In particular, we train on threads that have non-zero activity between weeks W − 1 and W , fix the testing time window to ∆T = 1 week, and set K = 6. Since the exact procedures used in [27] to select the latent dimension in the "content level model," to select the number of close peers in the "social peer connections", and to aggregate these two into a single model for matrix factorization in AMF are not clear, we sweep over a range of values for these parameters and choose the values that maximize the performance of AMF. Fig. 5 compares the MAP@5 performance of our model against that of the PPL and AMF baselines for a range of values of W on the comp dataset (as in previous experiments, results on the other two datasets are similar). We see again that our model significantly outperforms both AMF and PPL in each case. Moreover, while AMF consistently outperforms PPL in agreement with the results in [27], the MAP@5 values of both baselines are significantly less than the values of 0.3 reported in [27]. We also emphasize that setting the length of the testing window to 1 week is too coarse of a timescale for thread recommendation in the MOOC discussion forum setting, Topic Half-life Top words 1 2 3 4 5 4 hours 4 hours 1 day 1 day 1 week gradient, row, element, iteration, return, transpose, logistic, multiply, initial, regularization layer, classification, probability, neuron, unit, hidden, digit, nn, sigmoid, weight interest, group, computer, Coursera, study, hello, everyone, student, learning, software Coursera, deadline, professor, hard, score, certificate, review, experience, forum, material screenshot, speed, player, subtitle, chrome, firefox, summary, reproduce, open, graph Table 2: Estimated half-lives and highest constituent words (obtained by sorting the estimated topic-word distribution param- eter vectors ϕk ) for selected topics in the ml dataset with at least 100 threads. Different types of topics (course content-related, small-talk, or course logistics) exhibit different half-lives. We observe topics with half-lives ranging from hours to weeks. We can use these timescales to categorize threads: course content- related topics (Topics 1 and 2) mostly have short half-lives of hours, small-talk topics (Topics 3 and 4) stay active for longer with half- lives of around one day, and course logistics topics (Topic 5) have much longer half-lives of around one week. Activities in threads on course content-related topics develop and decay rapidly, since they are most likely spurred by specific course materials or assignments. For example, posts on Topic 1 are about implementing gradient descent, which is covered in the second and third weeks of the course, and posts on Topic 2 are about neural networks, which is covered in the fourth and fifth weeks. Small-talk discussions are extremely common at the beginning and the end of the course, while course logistics discussions (e.g., concerning technical issues) are less frequent but steady in volume throughout the course. Excitation from notifications. Table 3 shows the estimated ad- ditional excitation induced by new activity notifications ((cid:98)α) and explicit replies ((cid:98)β). In each course, we see that notifications increase higher than without any notification. Notice also that(cid:98)β is lowest while(cid:98)α is highest in comp. This observation is consistent with the the likelihood of participation significantly; for example, in ml, a learner's likelihood of posting after an explicit reply is 473 times fact that in humanities courses like comp the discussions in each thread will tend to be longer [2], leading to more new activity noti- fications, while in engineering courses like ml and algo we would expect learners to more directly answer each other's questions, leading to more explicit replies. 5 CONCLUSIONS AND FUTURE WORK In this paper, we proposed a point processed-based probabilistic model for MOOC discussion forum posts, and demonstrated its performance in thread recommendation and analytics using real- world datasets. Possible avenues of future work include (i) jointly analyzing discussion forum data and time-varying learner grades [11, 12] to better quantify the "flow of knowledge" between learners, (ii) incorporating up-votes and down-votes on the posts into the model, and (iii) leveraging the course syllabus to better model the emergence of new threads. Figure 6: Plot of the total number of posts on each topic week-by-week in the ml dataset. The week-to-week activity levels vary significantly across topics. Dataset (cid:98)α (cid:98)β ml 29.0 19.2 algo 23.3 12.2 comp 33.6 10.6 Table 3: Estimated levels of additional excitation brought by new activity notifications and explicit replies. where new discussions may emerge on a daily basis due to the release of new learning content, homework assignments, or exams. 4.4 Model analytics Beyond thread recommendation, we also explore a few types of analytics that our trained model parameters can provide. For this experiment, we set K = 10 in order to achieve finer granularity in the topics; we found that this leads to more useful analytics. Topic timescales and thread categories. Table 2 shows the esti- mated half-lives γk and most representative words for five selected topics in the ml dataset that are associated with at least 100 threads. Fig. 6 plots the total number of posts made on these topics each week during the course. 8 REFERENCES [1] D. Blei, A. Ng, and M. Jordan. 2003. Latent Dirichlet allocation. J. Mach. Learn. Res. 3 (Jan. 2003), 993–1022. [2] C. G. Brinton, S. Buccapatnam, F. Wong, M. Chiang, and H. V. Poor. 2016. Social learning networks: Efficiency optimization for MOOC forums. In Proc. IEEE Conf. Comput. Commun. 1–9. [3] C. G. Brinton, M. Chiang, S. Jain, H. Lam, Z. Liu, and F. Wong. 2014. Learning about social learning in MOOCs: From statistical analysis to generative model. IEEE Trans. Learn. Technol. 7, 4 (Oct. 2014), 346–359. [4] P. Brusilovsky, S. Somyürek, J. Guerra, R. Hosseini, V. Zadorozhny, and P. J. Durlach. 2016. Open social student modeling for personalized learning. IEEE Trans. Emerg. Topics Comput. 4, 3 (July 2016), 450–461. [5] G. Cong, L. Wang, C. Lin, Y. Song, and Y. Sun. 2008. Finding question-answer pairs from online forums. In Proc. ACM SIGIR Conf. Res. Dev. Inf. Retr. 467–474. [6] D. J. Daley and D. Vere-Jones. 2003. An Introduction to the Theory of Point Processes. Springer. [7] M. Farajtabar, S. Yousefi, L. Tran, L. Song, and H. Zha. 2015. A Continuous-time mutually-exciting point process framework for prioritizing events in social media. arXiv preprint arXiv:1511.04145 (Nov. 2015). [8] N. Gillani, R. Eynon, M. Osborne, I. Hjorth, and S. Roberts. 2014. Communication communities in MOOCs. arXiv preprint arXiv:1403.4640 (Mar. 2014). [9] A. Kardan, A. Narimani, and F. Ataiefard. 2017. A hybrid approach for thread recommendation in MOOC forums. International Journal of Social, Behavioral, Educational, Economic, Business and Industrial Engineering 11, 10 (2017), 2195– 2201. [10] M. Kim and J. Leskovec. 2011. The network completion problem: Inferring missing nodes and edges in networks. In Proc. ACM SIGKDD Intl. Conf. Knowl. Discov. Data Min. 47–58. [11] A. S. Lan, C. Studer, and R. G. Baraniuk. 2014. Time-varying learning and content analytics via sparse factor analysis. In Proc. ACM SIGKDD Intl. Conf. Knowl. Discov. Data Min. 452–461. [12] A. S. Lan, C. Studer, A. E. Waters, and R. G. Baraniuk. 2013. Joint topic modeling and factor analysis of textual information and graded response data. In Proc. 6th Intl. Conf. Educ. Data Min. 324–325. [13] S. Linderman and R. Adams. 2014. Discovering latent network structure in point process data. In Intel. Conf. Mach. Learn. 1413–1421. [14] D. Luo, H. Xu, Y. Zhen, X. Ning, H. Zha, X. Yang, and W. Zhang. 2015. Multi-task multi-dimensional Hawkes processes for modeling event sequences. In Proc. Intl. Joint Conf. Artif. Intell. 3685–3691. [15] F. Mi and B. Faltings. 2017. Adaptive sequential recommendation for discussion forums on MOOCs using context trees. In Proc. Intl. Conf. Educ. Data Min. 24–31. [16] K. Miller, M. I. Jordan, and T. L. Griffiths. 2009. Nonparametric latent feature models for link prediction. In Proc. Adv. Neural Inform. Process. Syst. 1276–1284. [17] M. Mozer and R. Lindsey. 2016. Neural Hawkes process memories. In NIPS Symp. Recurrent Neural Netw. [18] A. Ramesh, D. Goldwasser, B. Huang, H. Daumé III, and L. Getoor. 2014. Un- derstanding MOOC discussion forums using seeded LDA. In Proc. Conf. Assoc. Comput. Linguist. 28–33. [19] A. Ramesh, S. Kumar, J. Foulds, and L. Getoor. 2015. Weakly supervised models of aspect-sentiment for online course discussion forums.. In Proc. Conf. Assoc. Comput. Linguist. 74–83. [20] A. Ritter, C. Cherry, and B. Dolan. 2010. Unsupervised modeling of Twitter conversations. In Proc. Human Lang. Technol. 172–180. [21] X. Shi, J. Zhu, R. Cai, and L. Zhang. 2009. User grouping behavior in online forums. In Proc. ACM SIGKDD Intl. Conf. Knowl. Discov. Data Min. 777–786. [22] A. Simma and M. I. Jordan. 2010. Modeling events with cascades of Poisson processes. In Proc. Conf. Uncertain. Artif. Intell. 546–555. [23] S. Tomkins, A. Ramesh, and L. Getoor. 2016. Predicting post-test performance from online student behavior: A high school MOOC case study. In Proc. Intl. Conf. Educ. Data Min. 239–246. [24] H. Wang, C. Wang, C. Zhai, and J. Han. 2011. Learning online discussion structures by conditional random fields. In Proc. ACM SIGIR Conf. Res. Dev. Inf. Retr. 435–444. [25] X. Wang, D. Yang, M. Wen, K. Koedinger, and C. Rosé. 2015. Investigating how student's cognitive behavior in MOOC discussion forums affect learning gains. In Proc. Intl. Conf. Educ. Data Min. 226–233. [26] H. Wu, J. Bu, C. Chen, C. Wang, G. Qiu, L. Zhang, and J. Shen. 2010. Modeling dynamic multi-topic discussions in online forums.. In Proc. Conf. Am. Assoc. Artif. Intell. 1455–1460. [27] D. Yang, M. Piergallini, I. Howley, and C. Rose. 2014. Forum thread recom- mendation for massive open online courses. In Proc. Intl. Conf. Educ. Data Min. 257–260. 9
1711.10146
2
1711
2018-01-31T09:15:51
Structural Deep Embedding for Hyper-Networks
[ "cs.SI" ]
Network embedding has recently attracted lots of attentions in data mining. Existing network embedding methods mainly focus on networks with pairwise relationships. In real world, however, the relationships among data points could go beyond pairwise, i.e., three or more objects are involved in each relationship represented by a hyperedge, thus forming hyper-networks. These hyper-networks pose great challenges to existing network embedding methods when the hyperedges are indecomposable, that is to say, any subset of nodes in a hyperedge cannot form another hyperedge. These indecomposable hyperedges are especially common in heterogeneous networks. In this paper, we propose a novel Deep Hyper-Network Embedding (DHNE) model to embed hyper-networks with indecomposable hyperedges. More specifically, we theoretically prove that any linear similarity metric in embedding space commonly used in existing methods cannot maintain the indecomposibility property in hyper-networks, and thus propose a new deep model to realize a non-linear tuplewise similarity function while preserving both local and global proximities in the formed embedding space. We conduct extensive experiments on four different types of hyper-networks, including a GPS network, an online social network, a drug network and a semantic network. The empirical results demonstrate that our method can significantly and consistently outperform the state-of-the-art algorithms.
cs.SI
cs
Structural Deep Embedding for Hyper-Networks Ke Tu1, Peng Cui1, Xiao Wang1, Fei Wang2, Wenwu Zhu1 1 Department of Computer Science and Technology, Tsinghua University 2 Department of Healthcare Policy and Research, Cornell University [email protected], [email protected], [email protected] [email protected],[email protected] 8 1 0 2 n a J 1 3 ] I S . s c [ 2 v 6 4 1 0 1 . 1 1 7 1 : v i X r a Abstract Network embedding has recently attracted lots of attentions in data mining. Existing network embedding methods mainly focus on networks with pairwise relationships. In real world, however, the relationships among data points could go be- yond pairwise, i.e., three or more objects are involved in each relationship represented by a hyperedge, thus forming hyper-networks. These hyper-networks pose great challenges to existing network embedding methods when the hyperedges are indecomposable, that is to say, any subset of nodes in a hyperedge cannot form another hyperedge. These inde- composable hyperedges are especially common in hetero- geneous networks. In this paper, we propose a novel Deep Hyper-Network Embedding (DHNE) model to embed hyper- networks with indecomposable hyperedges. More specifi- cally, we theoretically prove that any linear similarity met- ric in embedding space commonly used in existing meth- ods cannot maintain the indecomposibility property in hyper- networks, and thus propose a new deep model to realize a non-linear tuplewise similarity function while preserving both local and global proximities in the formed embedding space. We conduct extensive experiments on four different types of hyper-networks, including a GPS network, an on- line social network, a drug network and a semantic network. The empirical results demonstrate that our method can signif- icantly and consistently outperform the state-of-the-art algo- rithms. Introduction Nowadays, networks are widely used to represent the rich relationships of data objects in various domains, forming so- cial networks, biology networks, brain networks, etc. Many methods are proposed for network analysis, among which network embedding methods (Tang et al. 2015; Wang, Cui, and Zhu 2016; Deng et al. 2016; Ou et al. 2015) arouse more and more interests in recent years. Most of the existing network embedding methods are designed for conventional pairwise networks, where each edge links only a pair of nodes. However, in real world applications, the relationships among data objects are much more complicated and they typically go beyond pairwise. For example, John purchas- ing a shirt with cotton material forms a high-order relation- ship (cid:104)John, shirt, cotton(cid:105). The network capturing those high- Copyright c(cid:13) 2018, Association for the Advancement of Artificial Intelligence (www.aaai.org). All rights reserved. order node relationships is usually referred to as a hyper- network. A typical way to analyze hyper-network is to expand them into conventional pairwise networks and then apply the an- alytical algorithms developed on pairwise networks. Clique expansion (Sun, Ji, and Ye 2008) (Figure 1 (c)) and star ex- pansion (Agarwal, Branson, and Belongie 2006) (Figure 1 (d)) are two representative techniques to achieve such a goal. In clique expansion, each hyperedge is expanded as a clique. In star expansion, a hypergraph is transformed into a bipar- tite graph where each hyperedge is represented by an in- stance node which links to the original nodes it contains. These methods assume that the hyperedges are decompos- able either explicitly or implicitly. That is to say, if we treat a hyperedge as a set of nodes, then any subset of nodes in this hyperedge can form another hyperedge. In a homoge- neous hyper-network, this assumption is reasonable, as the formation of hyperedges are, in most cases, caused by the la- tent similarity among the involved objects such as common labels. However, when learning the heterogeneous hyper- network embedding, we need to address the following new requirements. 1. Indecomposablity: The hyperedges in heterogeneous hyper-networks are usually indecomposable. In this case, a set of nodes in a hyperedge has a strong relationship, while the nodes in its subset does not necessarily have a strong relationship. For example, in the recommendation system with (cid:104)user, movie, tag(cid:105) relationships, the (cid:104)user, tag(cid:105) relationships are not typically strong. This means that we cannot simply decompose hyperedges using those tra- ditional expansion methods. 2. Structure Preserving: The local structures are preserved by the observed relationships in network embedding. However, due to the sparsity of networks, many exist- ing relationships are not observed. It is not sufficient for preserving hyper-network structure using only local struc- tures. And global structures, e.g. the neighborhood struc- ture, are required to address the sparsity problem. How to capture and preserve both local and global structures si- multaneously in a hyper-network is still an unsolved prob- lem. To address Indecomposablity issue, we design an inde- composable tuplewise similarity function. The function is 4, we introduce the proposed model in details. Experimental results are presented in section 5. Finally, we conclude in Section 6. Related work Our work is related to network embedding which aims to learn low-dimension representations for networks. Earlier works, such as Local Linear Embedding (LLE) (Roweis and Saul 2000), Laplacian eigenmaps (Belkin and Niyogi 2001) and IsoMap (Tenenbaum, De Silva, and Langford 2000), are based on matrix factorization. They express a network as a matrix where the entries represent relationships and cal- culate the leading eigenvectors as network representations. Eigendecomposition is a very expensive operation so these methods cannot efficiently scale to large real world net- works. Recently, DeepWalk (Perozzi, Al-Rfou, and Skiena 2014) learns latent representations of nodes in a network by modeling a stream of short random walks. LINE (Tang et al. 2015) optimizes an objective function which aims to pre- serve both the first-order and second-order proximities of networks. HOPE (Ou et al. 2016) extends the work to utilize higher-order information and M-NMF (Wang et al. 2017) incorporates the community structure into network embed- ding. Furthermore, due to the powerful representation abil- ity of deep learning (Niepert, Ahmed, and Kutzkov 2016), several network embedding methods based on deep learn- ing (Chang et al. 2015; Wang, Cui, and Zhu 2016) have been proposed. (Wang, Cui, and Zhu 2016) proposes a deep model with a semi-supervised architecture, which simulta- neously optimizes the first-order and second-order proxim- ity. (Chang et al. 2015) employs deep model to transfer dif- ferent objects in heterogeneous networks to unified vector representations. However, all of the above methods assume pairwise rela- tionships among objects in real world networks. In view of the aforementioned facts, a series of methods (Zhou, Huang, and Scholkopf 2006; Liu et al. 2013; Wu, Han, and Zhuang 2010) is proposed by generalizing spectral clustering tech- niques (Ng et al. 2001) to hypergraphs. Nevertheless, these methods focus on homogeneous hypergraph. They construct hyperedge by latent similarity like common label and pre- serve hyperedge implicitly. Therefore, they cannot preserve the structure of indecomposable hyperedges. For heteroge- neous hyper-network, the tensor decomposition (Kolda and Bader 2009; Rendle and Schmidt-Thieme 2010; Symeonidis 2016) may be directly applied to learn the embedding. Un- fortunately, the time cost of tensor decomposition is usually very expensive so it cannot scale efficiently to large network. Besides, HyperEdge Based Embedding (HEBE) (Gui et al. 2016) is proposed to model the proximity among partici- pating objects in each heterogeneous event as a hyperedge based on prediction. It does not take high-order network structure and high degree of sparsity into account which af- fects the predictive performance in our task. Notations and Definitions In this section, we define the problem of hyper-network em- bedding. The key notations used in this paper are shown in Figure 1: (a) An example of a hyper-network. (b) Our method. (c) The clique expansion. (d) The star expansion. Our method mod- els the hyperedge as a whole and the tuplewise similarity is pre- served. In clique expansion, each hyperedge is expanded into a clique. Each pair of nodes has explicit similarity. As for the star expansion, each node in one hyperedge links to a new node which stands for the origin hyperedge. Each pair of nodes in the origin hyperedge has implicit similarity for the reason that they link to the same node. directly defined over all the nodes in a hyperedge, ensur- ing that the subsets of a hyperedge are not incorporated in network embedding. We theoretically prove that the inde- composable tuplewise similarity function can not be a lin- ear function. Therefore, we realize the tuplewise similarity function with a deep neural network and add a non-linear activation function to make it highly non-linear. To address Structure Preserving issue, we design a deep autoencoder to learn node representations by reconstructing neighbor- hood structures, ensuring that the nodes with similar neigh- borhood structures will have similar embeddings. The tu- plewise similarity function and deep autoencoder are jointly optimized to simultaneously address the two issues. It is worthwhile to highlight the following contributions of this paper: • We investigate the problem of indecomposable hyper- network embedding, where indecomposibility of hyper- edges is a common property in hyper-networks but largely ignored in literature. We propose a novel deep model, named Deep Hyper-Network Embedding (DHNE), to learn embeddings for the nodes in heterogeneous hyper- networks, which can simultaneously address indecompos- able hyperedges while preserving rich structural informa- tion. The complexity of this method is linear to the num- ber of node and it can be used in large scale networks • We theoretically prove that any linear similarity metric in embedding space cannot maintain the indecomposibil- ity property in hyper-networks, and thus propose a novel deep model to simultaneously maintain the indecomposi- bility as well as the local and global structural information in hyper-networks. • We conduct experiments on four real-world information networks. The results demonstrate the effectiveness and efficiency of the proposed model. The remainder of this paper is organized as follows. In the next section, we review the related work. Section 3 gives the preliminaries and formally defines our problem. In Section explicit similarityU2𝐿1𝐴2U2𝐿2𝐴2U1𝐿2𝐴1…𝑈1𝐿2𝐴1U2𝐿1𝐴2𝒆𝟏𝒆𝟐𝒆𝟑𝒆𝟒𝐴2U2𝐴2𝐿1U2𝐿1…𝐴1U1𝐴1𝐿2U1𝐿2𝐴2𝑒1𝑒1U2𝑒1𝐿1…𝐴1𝑒4𝑒4U1𝑒4𝐿2implicit similaritytuplewisesimilarity(𝒂)(𝒃)(𝒄)(𝒅) Table 1: Notations. Symbols Meaning T A Xj i V = {Vt}T E = {(v1, v2, ..., vni )} t=1 S(X1, X2, ..., XN ) number of node types node set hyperedge set adjacency matrix of hyper-network embedding of node i with type j N-tuplewise similarity function W(i) j b(i) j the i-th layer weight matrix with type j the i-th layer biases with type j Table 1. First we give the definition of a hyper-network. Definition 1 (Hyper-network). A hyper-network is defined as a hypergraph G = (V, E) with the set of nodes V be- longing to T types V = {Vt}T t=1 and the set of edges E which may have more than two nodes E = {Ei = (v1, v2, ..., vni)}(ni ≥ 2). If the number of nodes is 2 for each hyperedge, the hyper-network degenerates to a net- work. The type of edge Ei is defined as the combination of types of nodes belonging to the edge. If T ≥ 2, the hyper- network is defined as a heterogeneous hyper-network. To obtain the embeddings in a hyper-network, the inde- composable tuplewise relationships need be preserved. We define the indecomposable structures as the first-order prox- imity of hyper-network: Definition 2 (The First-order Proximity of Hyper-network). The first-order proximity of hyper-network measures the N-tuplewise similarity between nodes. For any N vertexes v1, v2, ..., vN , if there exists a hyperedge among these N vertexes, the first-order proximity of these N vertexes is de- fined as 1, but this implies no first-order proximity for any subsets of these N vertexes. The first-order proximity implies the indecomposable similarity of several entities in real world. Meanwhile, real world networks are always incomplete and sparse. Only con- sidering first-order proximity is not sufficient for learning node embeddings. Higher order proximity needs to be con- sidered to fix this issue. We then introduce the second-order proximity of hyper-network to capture the global structure. Definition 3 (The Second-order Proximity of Hyper-net- work). The second-order Proximity of hyper-network mea- sures the proximity of to their neighborhood structures. For any node vi ∈ Ei, Ei/vi is defined as a neighborhood of vi. If vi's neighborhoods {Ei/vi f or any vi ∈ Ei} are similar to vj's, then vi's em- bedding xi should be similar to vj's embedding xj. For example, in Figure 1(a), A1's neighborhoods set is {(L2, U1), (L1, U2)}. A1 and A2 have second-order similar- ity since they have common neighborhood, (L1, U2). two nodes with respect Deep Hyper-Network Embedding In this section, we introduce the proposed Deep Hyper- Network Embedding (DHNE). The framework is shown in Figure 2. Figure 2: Framework of Deep Hyper-Network Embedding. Loss function To preserve the first-order proximity of a hyper-network, an N-tuplewise similarity measure in embedding space is re- quired. If there exists a hyperedge among N vertexes, the N-tuplewise similarity of these vertexes should be large, and small otherwise. Property 1. We mark Xi as the embedding of node vi and S as N-tuplewise similarity function. • if (v1, v2, ..., vN ) ∈ E, S(X1, X2, .., XN ) should be large (without loss of generality, large than a threshold l). • if (v1, v2, ..., vN ) /∈ E, S(X1, X2, .., XN ) should be small (without loss of generality, smaller than a thresh- old s). In our model, we propose a data-dependent N-tuplewise similarity function. In this paper, we mainly focus on hyper- edges with uniform length N = 3, but it is easy to extend to N > 3. Here we provide the theorem to demonstrate that a linear function S(X1, X2, ..., XN ) = tuplewise similarity function cannot satisfy Property 1. Theorem 1. Linear i WiXi cannot satisfy Property 1. (cid:80) Proof. To prove it by contradiction, we assume that theo- rem 1 is false, i.e., the linear function S satisfies Property 1. We suggest the following counter example. Assume we have 3 types of nodes, and each type of node has 2 clusters (0 and 1). There is a hyperedge if and only if 3 nodes from differ- ent types have the same cluster id. We use Yj i to represent embeddings of nodes with type j in cluster i. By Property 1, we have W1Y1 W1Y1 W1Y1 W1Y1 0 + W2Y2 1 + W2Y2 1 + W2Y2 0 + W2Y2 1 > l 0 > l 0 < s 0 + W3Y3 0 + W3Y3 1 + W3Y3 1 + W3Y3 (1) (2) (3) (4) 0 − 0) > l − s, which is a 1 < s. By combining Equation (1)(2)(3)(4), we get W1 ∗ (Y1 1) > l − s and W1 ∗ (Y1 Y1 contradiction. This completes the proof. 1 − Y1 second-orderfirst-order……………….……Unsupervised Heterogeneous ComponentSupervised Binary ComponentNon-linearmappingautoencoderautoencoderautoencoderNode Type 𝑎Node Type 𝑏Node Type 𝑐𝐴i𝑎,𝐴𝑗𝑏,𝐴𝑘𝑐𝑋i𝑎,𝑋𝑗𝑏,𝑋𝑘𝑐𝐿𝑖𝑗𝑘𝑆𝑖𝑗𝑘+1-1tuple-wise similarityFirst LayerSecond LayerThird Layer Above theorem shows that N-tuplewise similarity func- tion S should be in a non-linear form. This motivates us to model it by a multilayer perceptron. The multilayer percep- tron is composed of two parts, which are shown separately in the second layer and third layer of Figure 2. The second layer is a fully connected layer with non-linear activation functions. With the input of the embeddings (Xa j, Xc k) of 3 nodes (vi, vj, vk), we concatenate them and map them non-linearly to a common latent space L. Their joint repre- sentation in latent space is shown as follows: c ∗Xc b ∗Xb Lijk = σ(W(2) where σ is the sigmoid function. k +b(2)), (5) a ∗Xa i +W(2) j +W(2) i , Xb After obtaining the latent representation Lijk, we finally map it to a probability space in the third layer to get the similarity: j, Xc i , Xb k) = σ(W(3) ∗ Lijk + b(3)). Sijk ≡ S(Xa (6) Combining the aforementioned two layers, we obtain a non-linear tuplewise similarity measure function S. In or- der to make this similarity function satisfy Property 1, we present the objective function as follows: the degree of vertex is defined by d(v) =(cid:80) L1 = −(Rijk log Sijk + (1 − Rijk) log(1 − Sijk)), (7) where Rijk is defined as 1 if there is a hyperedge between vi, vj and vk and 0 otherwise. From the objective function, it is easy to check that if Rijk equals to 1, the similarity Sijk should be large, and otherwise the similarity should be small. In other words, the first-order proximity is preserved. Next, we consider to preserve the second-order proxim- ity. The first layer of Figure 2 is designed to preserve the second-order proximity. Second-order proximity measures neighborhood structure similarity. Here, we define the adja- cency matrix of hyper-network to capture the neighborhood structure. First, we give some basic definitions of hyper- graph. For a hypergraph G = (V, E), a V ∗ E incidence matrix H with entries h(v, e) = 1 if v ∈ e and 0 otherwise, is defined to represent the hypergraph. For a vertex v ∈ V, e∈E h(v, e). Let Dv denote the diagonal matrix containing the vertex degree. Then the adjacency matrix A of hypergraph G can be de- fined as A = HHT − Dv, where HT is the transpose of H. The entries of adjacency matrix A denote the concurrent times between two nodes, and the i-th row of adjacency ma- trix A shows the neighborhood structure of vertex vi. We use an adjacency matrix A as our input feature and an au- toencoder (LeCun, Bengio, and Hinton 2015) as the model to preserve the neighborhood structure. The autoencoder is composed by an encoder and a decoder. The encoder is a non-linear mapping from feature space A to latent represen- tation space X and the decoder is a non-linear mapping from latent representation X space back to origin feature space A, which is shown as follows: Xi = σ(W(1) ∗ Ai + b(1)) Ai = σ( W(1) ∗ Xi + b(1)). (8) (9) The goal of autoencoder is to minimize the reconstruc- tion error between the input and the output. The autoen- coder's reconstruction process will make the nodes with similar neighborhoods have similar latent representations, and thus the second-order proximity is preserved. It is note- worthy that the input feature is the adjacency matrix of the hyper-network, and the adjacency matrix is often extremely sparse. To speed up our model, we only reconstruct non-zero element in the adjacency matrix. The reconstruction error is shown as follows: sign(Ai) (cid:12) (Ai − Ai)2 F , (10) where sign is the sign function. Furthermore, in hyper-networks, the vertexes often have various types, forming heterogeneous hyper-networks. Con- sidering the special characteristics of different types of nodes, it is required to learn unique latent spaces for dif- ferent node types. In our model, each heterogeneous type of entities have their own autoencoder model as shown in Fig- ure 2. Then for all types of nodes, the loss function is defined as: (cid:88) L2 = sign(At i) (cid:12) (At i − At i)2 F , (11) t where t is the index for node types. To preserve both first-order proximity and second-order proximity of heterogeneous hyper-networks, we jointly min- imize the objective function by combining Equation 7 and Equation 11: L = L1 + αL2. (12) Optimization We use stochastic gradient descent (SGD) to optimize the model. The key step is to calculate the partial deriva- tive of the parameters θ = {W(i), b(i), W(i), b(i)}3 i=1. These derivatives can be easily estimated by using back- propagation algorithm (LeCun, Bengio, and Hinton 2015). Notice that there is only positive relationship in most real world network, so this algorithm may converge to a trivial solution where all tuplewise relationships are similar. To ad- dress this problem, we sample multiple negative edges based on noisy distribution for each edge, as in (Mikolov et al. 2013). The whole algorithm is shown in Algorithm 1. Analysis In this section, we present the out-of-sample extension and complexity analysis. Out-of-sample extension For a newly arrived vertex v, we can easily obtain its adjacency vector by its connections to existing vertexes. We feed its adjacency vector into the spe- cific autoencoder corresponding to its type, and apply Equa- tion 8 to get representation for vertex v. The complexity for such steps is O(dvd), where dv is the degree of vertex v and d is the dimensionality of the embedding space.. Algorithm 1 The Deep Hyper-Network Embedding (DHNE) Require: the hyper-network G = (V, E) with adjacency Ensure: Hyper-network Embeddings E and updated Pa- matrix A, the parameter α rameters θ = {W(i), b(i), W(i), b(i)}3 1: initial parameters θ by random process 2: while the value of objective function do not converge i=1 do 3: 4: 5: generate next batch from the hyperedge set E sample negative hyperedge randomly calculate partial derivative ∂L/∂θ with back- propagation algorithm to update θ. 6: end while Complexity analysis During the training procedure, the time complexity of calculating gradients and updating pa- rameters is O((nd + dl + l)bI), where n is the number of nodes, d is the dimension of embedding vectors, l is the size of latent layer, b is the batch size and I is the number of it- erations. Parameter l is usually related to the dimension of embedding vectors d but independent with the number of vertexes n. The batch size is normally a small number. The number of iterations is also not related with the number of vertexes n. Therefore, the complexity of training procedure is linear to the number of vertexes. Experiment In this section, we evaluate our proposed method on several real world datasets and multiple application scenarios. Datasets In order to comprehensively evaluate the effectiveness of our proposed method, we use four different types of datasets, including a GPS network, a social network, a medicine net- work and a semantic network. The detailed information is shown as follows. • GPS (Zheng et al. 2010): The dataset describes a user joins in an activity in certain location. The (user, loca- tion, activity) relations are used for building the hyper- network. • MovieLens (Harper and Konstan 2016): This dataset de- scribes personal tagging activity from MovieLens1. Each movie is labeled by at least one genres. The (user, movie, tag) relations are considered as the hyperedges to form a hyper-network. • drug2: This dataset is obtained from FDA Adverse Event Reporting System (FAERS). It contains information on adverse event and medication error reports submitted to FDA. We construct hyper-network by (user, drug, reac- tion) relationships, i.e., a user who has certain reaction and takes some drugs will lead to adverse event. 1https://movielens.org/ 2http://www.fda.gov/Drugs/ Table 2: Statistics of the datasets. node type location movie drug relation user user user head activity reaction tag tail #(V) 70 5908 1076 18 146 2113 12 40504 5 9079 6398 40551 #(E) 1436 47957 171756 145966 datasets GPS MovieLens drug wordnet • wordnet (Bordes et al. 2013): This dataset consists of a collection of triplets (synset, relation type, synset) ex- tracted from WordNet 3.0. We can construct the hyper- network by regarding head entity, relation, tail entity as three types of nodes and the triplet relationships as hyper- edges. The detailed statistics of the datasets are summarized in Ta- ble 2. Parameter Settings We compared DHNE against the following six widely-used algorithms: DeepWalk (Perozzi, Al-Rfou, and Skiena 2014), LINE (Tang et al. 2015), node2vec (Grover and Leskovec 2016), Spectral Hypergraph Embedding (SHE) (Zhou, Huang, and Scholkopf 2006), Tensor decomposition (Kolda and Bader 2009) and HyperEdge Based Embedding (HEBE) (Gui et al. 2016). In summary, DeepWalk, LINE and node2vec are conven- tional pairwise network embedding methods. In our experi- ment, we use clique expansion in Figure 1(c) to transform a hyper-network in a conventional network, and then use these three methods to learn node embeddings from the conven- tional networks. SHE is designed for homogeneous hyper- network embeddings. Tensor method is a direct way for preserving high-order relationship in heterogeneous hyper- network. HEBE learns node embeddings for heterogeneous event data. Note that DeepWalk, LINE , node2vec and SHE can only measure pairwise relationship. In order to make them applicable to network reconstruction and link predic- tion in hyper-networks, without loss of generality, we use the mean or minimum value among all pairwise similarities in a candidate hyperedge to represent the tuplewise similar- ity of the hyperedge. For DeepWalk and node2vec, we set window size as 10, walk length as 40, walks per vertex as 10. For LINE, we set the number of negative samples as 5. We uniformly set the representation size as 64 for all methods. Specifically, for DeepWalk and node2vec, we set window size as 10, walk length as 40, walks per vertex as 10. For LINE, we set the number of negative samples as 5. For our model, we use one-layer autoencoder to preserve hyper-network structure and one-layer fully connected layer to learn tuplewise similarity function. The size of hidden layer of autoencoder is set as 64 which is also the repre- sentation size. The size of fully connect layer is set as sum of the embedding length from all types, 192. We do grid search from {0.01, 0.1, 1, 2, 5, 10} to tune the parameter α which is shown in Parameter Sensitivity section. Similar to LINE (Tang et al. 2015), the learning rate is set with the starting value ρ0 = 0.025 and decreased linearly with the times of iterations. Table 3: AUC value for network reconstruction. methods DHNE mean min deepwalk line node2vec SHE deepwalk line node2vec SHE tensor HEBE GPS MovieLens 0.9598 0.6714 0.8058 0.6715 0.8596 0.6034 0.7369 0.6578 0.7981 0.9229 0.9337 0.9344 0.8233 0.8431 0.9142 0.7530 0.7117 0.7910 0.9100 0.7972 0.8640 0.8772 drug 0.9356 0.5750 0.6908 0.6694 0.5486 0.5321 0.7625 0.6557 0.6236 0.7025 0.8236 wordnet 0.9073 0.8176 0.8365 0.8609 0.5618 0.7423 0.7751 0.8387 0.5918 0.7771 0.7391 Network Reconstruction A good network embedding method should preserve the original network structure well in the embedding space. We first evaluate our proposed algorithm on network re- construction task. We use the learned embeddings to pre- dict the links of origin networks. The AUC (Area Under the Curve) (Fawcett 2006) is used as the evaluation metric. The results are show in Table 3. From the results, we have the following observations: • Our method achieves significant improvements on AUC values over the baselines on all four datasets. It demon- strates that our method is able to preserve the origin net- work structure well. • Compared with the baselines, our method achieves higher improvements in sparse drug and wordnet datasets than those on GPS and MovieLens datasets. It indicates the ro- bustness of proposed methods on sparse datasets. • The results of DHNE perform better than DeepWalk, LINE and SHE which assume that high-order rela- tionships are decomposable. It demonstrates the impor- tance of preserving indecomposable hyperedge in hyper- network. Link Prediction Link prediction is a widely-used application in real world especially in recommendation systems. In this section, we fulfil two link prediction tasks on all the four datasets. The two tasks evaluate the overall performance and the perfor- mance with different sparsity of the networks, respectively. We calculate AUC value as in network reconstruction task to evaluate the performance. For the first task, we randomly hide 20 percentage of ex- isting edges and use the left network to train hyper-network embedding models. After training, we obtain embedding for each node and similarity function for N nodes and apply the similarity function to predict the held-out links. For GPS dataset which is a small and dense dataset, we can draw ROC curve for this task to observe the performance at vari- ous threshold settings, as shown in Figure 3 left. The AUC results on all datasets are shown in Table 4. The observations are illustrated as follows: Figure 3: left: ROC curve on GPS; right: Performance for link prediction on networks of different sparsity. Table 4: AUC value for link prediction. methods DHNE mean min deepwalk line node2vec SHE deepwalk line node2vec SHE tensor HEBE GPS MovieLens 0.9166 0.6593 0.7795 0.5835 0.8687 0.5715 0.7219 0.5869 0.8078 0.8646 0.8355 0.8676 0.7151 0.7170 0.8211 0.7459 0.6307 0.6265 0.7675 0.8012 0.7201 0.7740 drug 0.9254 0.5822 0.7057 0.6573 0.5899 0.5493 0.7651 0.6546 0.6508 0.6470 0.8191 wordnet 0.8268 0.5952 0.6819 0.8003 0.5426 0.5542 0.6225 0.7985 0.5507 0.6516 0.6364 • Our method achieves significant improvements over the baselines on all the datasets. It demonstrates the learned embeddings of our method have strong predictive power for unseen links. • By comparing the performance of LINE, DeepWalk, SHE and DHNE, we can observe that transforming the in- decomposable high-order relationship into multiple pair- wise relationship will damage the predictive power of the learned embeddings. • As Tensor and HEBE can somewhat address the indecom- posibility of hyperedges, the large improvement margin of our method over these two methods clearly demonstrates the importance of second-order proximities in hyper- network embedding. For the second task, we change the sparsity of network by randomly hiding different ratios of existing edges and repeat the previous task. Particularly, we conduct this task on the drug dataset as it has the most hyperedges. The ratio of re- mained edges is selected from 10% to 90%. The results are shown in Figure 3 right. We can observe that DHNE has a significant improve- ments over the best baselines on all sparsity of networks. It demonstrates the effectiveness of DHNE on sparse net- works. 0.00.20.40.60.81.0Percentage0.50.60.70.80.9AUC0.00.10.20.30.40.50.60.70.80.91.0False Positive Rate0.00.10.20.30.40.50.60.70.80.91.0True Positive RateDHNEdeepwalk(mean)deepwalk(min)line(mean)line(min)node2vec(mean)node2vec(min)SHE(mean)SHE(min)tensorHEBE Figure 5: left, middle: Parameter w.r.t. embedding dimensions d, the value of α; right: training time per batch w.r.t. embedding di- mensions. when the number of embedding dimension increases. This is reasonable because higher embedding dimensions can em- body more information of a hyper-network. After the em- bedding dimension is larger than 32, the curve is relatively stable, demonstrating that our algorithm is not very sensitive to embedding dimension. Effect of parameter α The parameter α measures the trade-off of the first-order proximity and second-order prox- imity of a hyper-network. We show how the values of α af- fect the performance in Figure 5 middle. When α equals 0, only the first-order proximity is taken into account in our method. The performance with α between 0.1 and 2 is bet- ter than that of α = 0, demonstrating the importance of second-order proximity. The fact that the performance with α between 0.1 and 2 is better than that of α = 5 can demon- strate the importance of the first-order proximity. In sum- mary, both the first-order proximity and the second-order proximity are necessary for hyper-network embedding. Training time analysis To testify the scalability, we test training time per batch, as shown in Figure 5 right. We can observe that the training time scales linearly with the num- ber of nodes. This results conform to the above complexity analysis and indicate the scalability of our model. Conclusion In this paper, we propose a novel deep model named DHNE to learn the low-dimensional representation for hyper- networks with indecomposible hyperedges. More specifi- cally, we theoretically prove that any linear similarity met- ric in embedding space commonly used in existing methods cannot maintain the indecomposibility property in hyper- networks, and thus propose a new deep model to realize a non-linear tuplewise similarity function while preserving both local and global proximities in the formed embedding space. We conduct extensive experiments on four different types of hyper-networks, including a GPS network, an on- line social network, a drug network and a semantic network. The empirical results demonstrate that our method can sig- nificantly and consistently outperform the state-of-the-art al- gorithms. Acknowledgments This work is supported by National Program on Key Basic Research Project No. 2015CB352300, National Natural Sci- ence Foundation of China Major Project No. U1611461; Na- tional Natural Science Foundation of China No. 61772304, Figure 4: top: multi-label classification on MovieLens dataset; bottom: multi-class classification on wordnet dataset. Classification In this section, we conduct multi-label classification (Bha- tia et al. 2015) on MovieLens dataset and multi-class clas- sification in wordnet, because only these two datasets have label or category information. After deriving the node em- beddings from different methods, we choose SVM as the classifier. For MovieLens dataset, we randomly sample 10% to 90% of the vertexes as the training samples and use the left vertexes to test the performance. For wordnet dataset, the portion of training data is selected from 1% to 10%. Besides, we remove the nodes without labels on these two datasets. Averaged Macro-F1 and Micro-F1 are used to evaluate the performance. The results are shown in Figure 4. From the results, we have following observations: • In both Micro-F1 and Macro-F1 curves, our method per- forms consistently better than baselines. It demonstrates the effectiveness of our proposed method in classification tasks. • When the labelled data becomes richer, the relative im- provement of our method is more obvious than baselines. Besides, as shown in Figure 4 bottom, when the labeled data is quite sparse, our method still outperforms the base- lines. This demonstrates the robustness of our method. Parameter Sensitivity In this section, we investigate how parameters influence the performance and training time. Especially, we evaluate the effect of the ratio of first-order proximity loss and second- order proximity loss α and the embedding dimension d. For brevity, we report the results by link prediction task with drug dataset. Effect of embedding dimension We show how the di- mension of embedding space affects the performance in Fig- ure 5 left. We can see that the performance raises firstly 0.00.20.40.60.81.00.400.410.420.430.440.450.460.470.48Micro-F10.00.20.40.60.81.00.100.120.140.160.180.200.220.240.26Macro-F10.000.020.040.060.080.10Percentage0.100.120.140.160.180.200.220.240.260.280.30Micro-F10.000.020.040.060.080.10Percentage0.000.020.040.060.080.100.120.14Macro-F1DHNEdeepwalklinenode2vecSHEtensorHEBE012345alpha0.880.890.900.910.920.930.940.95AUC20406080100120dimension0.820.840.860.880.900.920.94AUC020000400006000080000number of nodes(*104)0.00.20.40.60.81.01.21.4time(s) 61521002, 61531006, 61702296; NSF IIS-1650723 and IIS- 1716432. Thanks for the research fund of Tsinghua-Tencent Joint Laboratory for Internet Innovation Technology, and the Young Elite Scientist Sponsorship Program by CAST. Peng Cui, Xiao Wang and Wenwu Zhu are the corresponding au- thors. All opinions, findings, conclusions and recommenda- tions in this paper are those of the authors and do not neces- sarily reflect the views of the funding agencies. References [Agarwal, Branson, and Belongie 2006] Agarwal, S.; Bran- son, K.; and Belongie, S. 2006. Higher order learning with graphs. In Proceedings of the 23rd international conference on Machine learning, 17–24. ACM. [Belkin and Niyogi 2001] Belkin, M., and Niyogi, P. 2001. Laplacian eigenmaps and spectral techniques for embedding and clustering. In NIPS, volume 14, 585–591. [Bhatia et al. 2015] Bhatia, K.; Jain, H.; Kar, P.; Varma, M.; and Jain, P. 2015. Sparse local embeddings for extreme multi-label classification. In Advances in Neural Informa- tion Processing Systems, 730–738. [Bordes et al. 2013] Bordes, A.; Usunier, N.; Garcia-Duran, A.; Weston, J.; and Yakhnenko, O. 2013. Translating em- beddings for modeling multi-relational data. In Advances in neural information processing systems, 2787–2795. [Chang et al. 2015] Chang, S.; Han, W.; Tang, J.; Qi, G.-J.; Aggarwal, C. C.; and Huang, T. S. 2015. Heterogeneous net- work embedding via deep architectures. In Proceedings of the 21th ACM SIGKDD International Conference on Knowl- edge Discovery and Data Mining, 119–128. ACM. [Deng et al. 2016] Deng, C.; Tang, X.; Yan, J.; Liu, W.; and Gao, X. 2016. Discriminative dictionary learning with com- mon label alignment for cross-modal retrieval. IEEE Trans- actions on Multimedia 18(2):208–218. [Fawcett 2006] Fawcett, T. 2006. An introduction to roc analysis. Pattern recognition letters 27(8):861–874. [Grover and Leskovec 2016] Grover, A., and Leskovec, J. 2016. node2vec: Scalable feature learning for networks. In Proceedings of the 22nd ACM SIGKDD international con- ference on Knowledge discovery and data mining, 855–864. ACM. [Gui et al. 2016] Gui, H.; Liu, J.; Tao, F.; Jiang, M.; Norick, B.; and Han, J. 2016. Large-scale embedding learning in heterogeneous event data. In ICDM. [Harper and Konstan 2016] Harper, F. M., and Konstan, J. A. 2016. The movielens datasets: History and context. ACM Transactions on Interactive Intelligent Systems (TiiS) 5(4):19. [Kolda and Bader 2009] Kolda, T. G., and Bader, B. W. 2009. Tensor decompositions and applications. SIAM re- view 51(3):455–500. [LeCun, Bengio, and Hinton 2015] LeCun, Y.; Bengio, Y.; Nature and Hinton, G. 521(7553):436–444. [Liu et al. 2013] Liu, Y.; Shao, J.; Xiao, J.; Wu, F.; and Zhuang, Y. 2013. Hypergraph spectral hashing for image Deep learning. 2015. retrieval with heterogeneous social contexts. Neurocomput- ing 119:49–58. [Mikolov et al. 2013] Mikolov, T.; Sutskever, I.; Chen, K.; Corrado, G. S.; and Dean, J. 2013. Distributed represen- tations of words and phrases and their compositionality. In Advances in neural information processing systems, 3111– 3119. [Ng et al. 2001] Ng, A. Y.; Jordan, M. I.; Weiss, Y.; et al. 2001. On spectral clustering: Analysis and an algorithm. In NIPS, volume 14, 849–856. [Niepert, Ahmed, and Kutzkov 2016] Niepert, M.; Ahmed, M.; and Kutzkov, K. 2016. Learning convolutional neu- ral networks for graphs. In Proceedings of the 33rd annual international conference on machine learning. ACM. [Ou et al. 2015] Ou, M.; Cui, P.; Wang, F.; Wang, J.; and Zhu, W. 2015. Non-transitive hashing with latent similarity components. In Proceedings of the 21th ACM SIGKDD In- ternational Conference on Knowledge Discovery and Data Mining, 895–904. ACM. [Ou et al. 2016] Ou, M.; Cui, P.; Pei, J.; Zhang, Z.; and Zhu, W. 2016. Asymmetric transitivity preserving graph embed- ding. In KDD, 1105–1114. [Perozzi, Al-Rfou, and Skiena 2014] Perozzi, B.; Al-Rfou, R.; and Skiena, S. 2014. Deepwalk: Online learning of In Proceedings of the 20th ACM social representations. SIGKDD international conference on Knowledge discovery and data mining, 701–710. ACM. and [Rendle and Schmidt-Thieme 2010] Rendle, Pairwise interaction tensor Schmidt-Thieme, L. factorization for personalized tag recommendation. In Proceedings of the third ACM international conference on Web search and data mining, 81–90. ACM. [Roweis and Saul 2000] Roweis, S. T., and Saul, L. K. 2000. Nonlinear dimensionality reduction by locally linear embed- ding. science 290(5500):2323–2326. [Sun, Ji, and Ye 2008] Sun, L.; Ji, S.; and Ye, J. 2008. Hy- pergraph spectral learning for multi-label classification. In Proceedings of the 14th ACM SIGKDD international con- ference on Knowledge discovery and data mining, 668–676. ACM. [Symeonidis 2016] Symeonidis, P. 2016. Matrix and tensor decomposition in recommender systems. In Proceedings of the 10th ACM Conference on Recommender Systems, 429– 430. ACM. [Tang et al. 2015] Tang, J.; Qu, M.; Wang, M.; Zhang, M.; Yan, J.; and Mei, Q. 2015. Line: Large-scale information In Proceedings of the 24th Interna- network embedding. tional Conference on World Wide Web, 1067–1077. ACM. [Tenenbaum, De Silva, and Langford 2000] Tenenbaum, J. B.; De Silva, V.; and Langford, J. C. 2000. A global ge- ometric framework for nonlinear dimensionality reduction. science 290(5500):2319–2323. [Wang et al. 2017] Wang, X.; Cui, P.; Wang, J.; Pei, J.; Zhu, W.; and Yang, S. 2017. Community preserving network embedding. 2010. S., [Wang, Cui, and Zhu 2016] Wang, D.; Cui, P.; and Zhu, W. In Proceed- 2016. Structural deep network embedding. ings of the 22nd ACM SIGKDD International Conference on Knowledge Discovery and Data Mining, 1225–1234. ACM. [Wu, Han, and Zhuang 2010] Wu, F.; Han, Y.-H.; and Zhuang, Y.-T. 2010. Multiple hypergraph clustering of web Journal of images by mining word2image correlations. Computer Science and Technology 25(4):750–760. [Zheng et al. 2010] Zheng, V. W.; Cao, B.; Zheng, Y.; Xie, X.; and Yang, Q. 2010. Collaborative filtering meets mo- bile recommendation: A user-centered approach. In AAAI, volume 10, 236–241. [Zhou, Huang, and Scholkopf 2006] Zhou, D.; Huang, J.; and Scholkopf, B. 2006. Learning with hypergraphs: Clus- tering, classification, and embedding. In NIPS, volume 19, 1633–1640.
1705.03193
1
1705
2017-05-09T06:11:30
Ad-blocking: A Study on Performance, Privacy and Counter-measures
[ "cs.SI", "cs.CY" ]
Many internet ventures rely on advertising for their revenue. However, users feel discontent by the presence of ads on the websites they visit, as the data-size of ads is often comparable to that of the actual content. This has an impact not only on the loading time of webpages, but also on the internet bill of the user in some cases. In absence of a mutually-agreed procedure for opting out of advertisements, many users resort to ad-blocking browser-extensions. In this work, we study the performance of popular ad-blockers on a large set of news websites. Moreover, we investigate the benefits of ad-blockers on user privacy as well as the mechanisms used by websites to counter them. Finally, we explore the traffic overhead due to the ad-blockers themselves.
cs.SI
cs
Ad-blocking: A Study on Performance, Privacy and Counter-measures Kiran Garimella Aalto University Helsinki, Finland kiran.garimella@aalto.(cid:27) Orestis Kostakis Aalto University Helsinki, Finland orestis.kostakis@aalto.(cid:27) Michael Mathioudakis Aalto University Helsinki, Finland michael.mathioudakis@aalto.(cid:27) 7 1 0 2 y a M 9 ] I S . s c [ 1 v 3 9 1 3 0 . 5 0 7 1 : v i X r a ABSTRACT Many internet ventures rely on advertising for their revenue. How- ever, users feel discontent by the presence of ads on the websites they visit, as the data-size of ads is often comparable to that of the actual content. This has an impact not only on the loading time of webpages, but also on the internet bill of the user in some cases. In absence of a mutually-agreed procedure for opting out of advertise- ments, many users resort to ad-blocking browser-extensions. In this work, we study the performance of popular ad-blockers on a large set of news websites. Moreover, we investigate the bene(cid:27)ts of ad-blockers on user privacy as well as the mechanisms used by websites to counter them. Finally, we explore the tra(cid:28)c overhead due to the ad-blockers themselves. ACM Reference format: Kiran Garimella, Orestis Kostakis, and Michael Mathioudakis. 2017. Ad- blocking: A Study on Performance, Privacy and Counter-measures. In Pro- ceedings of WebSci '17, Troy, NY, USA, June 25-28, 2017, 4 pages. DOI: http://dx.doi.org/10.1145/3091478.3091514 INTRODUCTION Ad-blocking is now a widespread practice among web users. Ac- cording to current estimates, it is employed by around 200 million desktop and 300 million mobile users, a user base that still grows at 40% annually [7]. The same estimates indicate that ad-blocking translates into signi(cid:27)cant losses for publishers, reaching 41 billion US dollars for 2016. It is therefore not surprising that there is an arms race between publishers and advertisers, on one hand, and ad-blocking tools (or 'ad-blockers'), on the other1. In this context, it is clear that understanding the mechanisms implemented by ad-blockers and their e(cid:29)ects is of wide and continuous interest. In this paper, we study a number of popular ad-blockers and analyze their performance in desktop and mobile settings for a large number of webpages. Speci(cid:27)cally, we employ the ad-blockers on two sets of webpages: one consisting of the front pages of popular news websites; and another consisting of around 30,000 web articles. 1https://techcrunch.com/2016/08/11/facebooks-blocker-blocking-ads-blocked-by- blockers/ Permission to make digital or hard copies of all or part of this work for personal or classroom use is granted without fee provided that copies are not made or distributed for pro(cid:27)t or commercial advantage and that copies bear this notice and the full citation on the (cid:27)rst page. Copyrights for components of this work owned by others than the author(s) must be honored. Abstracting with credit is permitted. To copy otherwise, or republish, to post on servers or to redistribute to lists, requires prior speci(cid:27)c permission and/or a fee. Request permissions from [email protected]. WebSci '17, Troy, NY, USA © 2017 Copyright held by the owner/author(s). Publication rights licensed to ACM. 978-1-4503-4896-6/17/06...$15.00 DOI: http://dx.doi.org/10.1145/3091478.3091514 For each webpage, we collect a number of measures that describe the browser workload with and without the use of an ad-blocker – including, for instance, the amount of data loaded, the load-time of webpages, or the number of data requests. Our results indicate that ad-blockers decrease the data consumption signi(cid:27)cantly, though the bene(cid:27)ts in terms of load times are limited. Moreover, by taking a deeper look into the set of requests incurred by websites and ad- blockers, we identify cases where the websites attempt to counter the ad-blockers, but also requests that the ad-blockers incur on their own. Finally, we investigate the extent to which ad-blockers pre- vent the transfer of user-tracking information, resulting in privacy bene(cid:27)ts for users. When comparing a range of di(cid:29)erent ad-blockers, we (cid:27)nd that uBlock performs the best, in terms of both data savings and user-tracking. RELATED WORK Online Advertising Advertising has emerged as one of the main sources of revenue on the web [2]. On one hand, advertisers claim that ads on the web help keep most parts of the web free for con- sumers [1]. On the other hand, consumers (cid:27)nd advertising annoying and obstructive. In one study, the New York Times analyzed the top 50 news websites2 and found that more than half of all data came from ads. Moreover, many users perceive web ads as a threat to privacy [3] and tracking is cited as one of the most common reasons for users to install ad-blockers [6]. This is corroborated by many studies that show large scale tracking behavior on the web [3, 9]. For instance, Yu et al. [12] (cid:27)nd that 95% of the pages visited contain 3rd party requests to potential trackers and 78% attempt to transfer unsafe data. To counter tracking, ad-blockers also remove tracking buttons (such as Facebook's 'like' button) and protect their users from known malware domains. Ad blocking In [4], the authors propose methods to detect the users who have installed an ad-blocker and characterize ad-block usage for a large set (2 millions) of users. In addition, they give details on demographics and geographic penetration of ad-blockers on the web. In [8], the authors analyze the use of two ad-blockers, AdblockPlus and Ghostery, on web tra(cid:28)c data from a European ISP. They show that there is a drop in requests to third party services when using ad-block and estimate that around 18% of the tra(cid:28)c is due to ads. There are a few di(cid:29)erences between our study and theirs: (i) their study handles only two ad-blockers, (ii) with a constant battle between advertisers and ad-blockers, the ad-blocking and counter ad-blocking scene has been changing over the last few years, and so have some of the related performance measurements. 2http://www.nytimes.com/interactive/2015/10/01/business/cost-of-mobile-ads.html WebSci '17, June 25-28, 2017, Troy, NY, USA Garimella, Kostakis, Mathioudakis (iii) our study handles in-html ads, which are used by advertisers nowadays to bypass ad-blocking. In [11], the authors classify third party trackers into various cat- egories including ad trackers, analytics, social, etc and compare the performance of various ad-blocking tools with respect to blocking these third party requests. They (cid:27)nd that there is a lot of variance in the type of requests that are blocked by each ad-blocker. They then look deeper into the individual default and possible con(cid:27)gurations of these ad-blockers and study the changes in blocking capabilities with the di(cid:29)erent settings. There have been privacy concerns with ad-blockers too. Many popular ad-blockers (including AdBlock and AdblockPlus) partici- pate in the Acceptable Ads program3, allowing 'non-intrusive' ads to go through. For an extensive study on the issue see [10]. To counter the e(cid:29)ects of increasing ad-blocking, advertisers are relying on counter-ad-blocking tools. In [5], the authors study their use on the most popular (cid:27)ve thousand websites and (cid:27)nd that at least 6.7% of these sites use them. DATA We analyze two datasets, chosen to capture potential di(cid:29)erences between content-heavy homepages of large websites and individual webpages. Top150 This is a list of the top 150 news websites, as ranked by Alexa4. For each of them, we have a URL that points to the website homepage, for both its desktop and mobile version (unless the latter does not exist). GDELT A list of 30,000 URLs pointing to di(cid:29)erent news articles published on a single day (November 8, 2016). The list was obtained from GDELT5, a project that collects news stories from all around the world over the years. We load the webpage of each URL with a clean instance of Chrome browser (no cached content or extensions), using the Se- lenium Python library6 on a Macbook pro with 8 cores, with no other major processes running. On each load, we capture the HAR (cid:27)le for the load. The HAR (HTTP Archive File) is a JSON-formatted (cid:27)le that captures the interactions between the browser and the website, including network requests, types and size of objects, and load times. We load the same URL in six browser modes, all simultaneously: a vanilla mode (no ad-blocker), and one mode for each of (cid:27)ve ad- blockers. The ad-blockers are AdBlock7, AdblockPlus8, Ghostery9, uBlock10 and Privacy Badger11 – chosen from the most popular ad-blockers on the Chrome Store. For the Top150 dataset, we also load the mobile version of the page (as loaded on Google Nexus 5) using Selenium's mobile emulation tool12. Note that, though we 3https://acceptableads.com/ 4http://www.alexa.com/topsites/category/News/Newspapers. We processed the list manually and removed a few which were not standard news sites (e.g. reddit.com) 5http://gdeltproject.org/ 6http://selenium-python.readthedocs.io/ 7https://getadblock.com/ 8https://adblockplus.org 9https://www.ghostery.com/ 10https://www.ublock.org 11https://www.e(cid:29).org/privacybadger 12https://sites.google.com/a/chromium.org/chromedriver/mobile-emulation report the data about mobile websites with and without ad-block, the ad-blockers used were for the desktop version. There are no ad-blockers for the mobile version of Chrome and none for any of the Android browsers. Our datasets and code can be accessed here13. FINDINGS This section details our (cid:27)ndings on the e(cid:28)ciency of ad-blockers, the ad-blocker bene(cid:27)ts on user privacy, the counter-measures used by advertisers, and (cid:27)nally the tra(cid:28)c load that ad-blockers incur on their own. Ad-blocker E(cid:28)ciency For each URL and setting (desktop or mobile, with or without ad- blocker), we collect measures that describe the average performance of the browser in loading the webpages of a dataset. The measures include: the number of distinct domains for all HTTP requests performed during loading; the maximum number of threads that run concurrently at any point; the total number of HTTP requests; the total size of downloaded and uploaded data; the cumulative time for loading the webpage, obtained by summing up the durations of all requests; and, (cid:27)nally, the wall-clock time. We acquire these statistics by parsing the HAR (cid:27)les. The number of distinct domains indicate the number of di(cid:29)erent parties that acquire information of the user, such as IP address and the user-agent string (contains device type, name and version of browser and OS, etc). The number of HTTP requests and maximum number of concurrent threads give an indication of the load on the user's machine. The amount of transferred data, and the cumulative and wall-clock time a(cid:29)ect the user experience. Figures 1 and 2 show the results for the desktop and mobile versions of the Top150 webpages; and Figure 3 for the GDELT webpages. Numbers represent the ratio of the measures over the vanilla mode – for example, a value of 0.6 for the number of domains means that using an ad-blocker loads 60% the number of domains compared to using no ad-blocker. We (cid:27)nd that: (i) All ad-blockers except Ghostery give around 25- 34% savings in the amount of data transferred (on average). This is a bit higher than the 18% saving reported by [8] and 13-34% reported by [11]. Ghostery is the exception because it is not an ad-blocking tool per se, but gives a choice for a user to track who is tracking them and block those of their choice. So by default Ghostery does not block any content. We still include it in all our measurements, as it still makes sense to study it in other analysis cases that follow in this section. (ii) On average, there is an increase in the wall clock time when using an ad-blocker, even as the cumulative time decreases for some of the ad-blockers. This means that ad-blockers incur overhead, but block ad-related threads that were meant to run in parallel while loading content; this overhead is not necessarily experienced by the user, since various scripts can often run in the background, after the important content has loaded. (iii) uBlock gives the best performance, both in terms of data and time saved. 13https://users.ics.aalto.(cid:27)/kiran/adblock/ Ad-blocking: A Study on Performance, Privacy and Counter-measures WebSci '17, June 25-28, 2017, Troy, NY, USA Figure 1: Performance benchmark when using an ad- blocker on the desktop version of Top150, normalized over the vanilla mode. Figure 3: Performance measures when using an ad-blocker on the GDELT dataset, normalized over the vanilla mode. Figure 2: Performance benchmark when using an ad- blocker on the mobile version of Top150, normalized over the vanilla mode. Privacy Badger was discarded because of inconsistencies in the data collection. Bene(cid:27)ts for User Privacy By examining the HTTP requests issued by the browser when load- ing a webpage, we notice that a signi(cid:27)cant amount of these are intended for tracking the users' behaviour. We attempt to quantify the potential privacy hazard for the user when accessing a webpage by analyzing the parameters passed through these requests. Speci(cid:27)- cally, to measure the impact of potentially privacy invading requests when using no ad-blocker, we manually examined the tracking pa- rameters from the request headers and found nine frequently used tracking parameters that accompanied a large set of requests. The parameters were: 'pixel', 'track', 'google_gid', 'user_id', 'partnerid', 'partnerUID', 'partner_device_id', 'uid', 'user_cookie'. The presence of these parameters o(cid:29)ers a high-precision method to identify user- tracking, although we currently do not quantify its recall. Figure 4 shows the fraction of requests containing one, two and three tracking parameters in a request when using an ad-blocker, again normalized over the vanilla mode. We can see from the (cid:27)gure Figure 4: Fraction of distinct requests containing tracking keywords for one, two and three tracking parameters. The black text in the red bar shows the total number of requests containing these tracking parameters in the vanilla mode. that, again, uBlock achieves near-perfect performance, whereas other ad-blockers (except Ghostery) block about 60-80% of requests with such parameters. The performance remains the same, when considering requests with di(cid:29)erent numbers of tracking parameters, though the total number of requests goes down exponentially. Blocking the Ad-blockers Online ventures relying on advertising try to counter to the ad- blocking tools [5]. In our analysis, we witness several techniques for countering ad-blockers, with di(cid:29)erent goals. In certain cases, the goal is simply to detect whether the browser has an active ad- blocking extension. Upon detection, a message is rendered on the webpage and noti(cid:27)es the user about the tool. This message may simply notify the user that the tool interferes with the content and the user-experience. Other times, the message blocks the user from accessing the actual content, until they have turned o(cid:29) the tool. In more extreme cases, the goal is to circumvent the ad-blocking tool altogether. DomainsMaxThreadsHTTPReqsDown.dataUp.dataCum.TimeWallclockTime0.00.20.40.60.81.01.21.41.61.8Normalized ScoreAdblockAdblockPlusUblockGhosteryPrivacy BadgerDomainsMaxThreadsHTTPReqsDown.dataUp.dataCum.TimeWallclockTime0.00.20.40.60.81.01.21.4Normalized ScoreAdblockAdblockPlusUblockGhosteryDomainsMaxThreadsHTTPReqsDown.dataUp.dataCum.TimeWallclockTime0.00.20.40.60.81.01.21.41.6Normalized ScoreAdblockAdblockPlusUblockGhosteryPrivacy Badgern = 1n = 2n = 30.00.20.40.60.81.0Normalized Score1,256,451141,12276,199AdblockAdblockPlusGhosteryPrivacy BadgerUBlock WebSci '17, June 25-28, 2017, Troy, NY, USA Garimella, Kostakis, Mathioudakis Table 1: Additional Domains loaded by Ad-blockers Ad-blocker AdBlock Adblock Plus Ghostery Privacy Badger uBlock Extra domains loaded mixpanel.com, stripe.com quantserve.com,crwdcntrl.net selectmedia.asia, streamrail.com adlooxtracking.com cdnjs.com Twitter widgets We examine again the HTTP requests performed when loading a webpage and look for speci(cid:27)c Javascript modules designed to counter ad-blocking, such as blockadblock.js, inn-anti- adblock, and adblock html cache buster. When web- pages from the GDELT dataset are loaded in the vanilla mode (no ad-blockers), we (cid:27)nd more than 3,260 webpages (10.8%) with ex- plicit attempts to determine if any ad-blocking tool is used. When AdBlock or AdblockPlus is activated, the number of webpages rises to 10,097 and 10,226 (33%), respectively, indicating that a large portion of webpages actively track the usage of these ad-blockers. When the other tools are used, the number of webpages with such requests is not as high; 15, 9, 8% of the webpages for Ghostery, Privacy Badger, and uBlock respectively. The variation in numbers between AdBlock and AdblockPlus, on one hand, and the rest of the ad-blockers, on the other, can be explained by the popu- larity of the former – but also the e(cid:29)ectiveness of the ad-blockers in blocking such requests. Requests due to Ad-blockers In this section, we try to dissect what additional requests are made when using an ad-blocker. Consider the set of HTTP requests re- quired to render a webpage in the vanilla mode, denoted by V. Let B be the set of requests when using an ad-blocking tool, then we de- (cid:27)ne A = V \B as the identi(cid:27)ed advertisements, and C = V ∩B as the "true" content of the page. Finally, E = B \V is "extra" content loaded due to or by the ad-blocking tool. Unsurprisingly, the most popular domains found in A are googlesyndication.com and doubleclick.net, in accordance to previous studies, and blocked (characterized as ads) by all tools. A more interesting question is to identify the "extra" E requests that incur exclusively at the presence by ad-blockers and to look for potential leakages in information14. The domains which most frequently occur only in E are shown in Table 1. In many cases, we notice that E contains well-known ad-serving or visitor-tracking domains. This clearly demonstrates that the tools are not perfect and are sometimes bypassed. For AdBlock, we notice that mixpanel.com appears in 5,125 (17%) of the webpages when using AdBlock, versus 170 (< 1%) of original pages (vanilla mode). This is a Google Analytics-like web- site that tracks visits by users of AdBlock. Similarly, stripe.com, an online payments platform through which users can donate to AdBlock is added to 2,616 (8%) of the webpages, compared to 40 (< 0.1%) with out ad-blocking. 14e.g. http://thehackernews.com/2016/11/web-of-trust-addon.html For Adblockplus, we notice an increase for quantserve .com (an audience-measurement website) from 14% to 21% and for crwdcntrl.net (another audience-measurement website) from 21% to 29% For Ghostery, we notice selectmedia.asia (a video-ad serving company) appears in 1,374 (4.6%) webpages' re- quests, compared to 47 (< 0.1%) in the vanilla mode, streamrail. com (another video-ad serving company) 1,488 times (5%) versus 63, and adlooxtracking.com (ad tracking company) 2,190 times (7%) versus 240 (< 1%). For PrivacyBadger, cdnjs.com (a repository for open-source web-libraries) stands out with 2,130 webpages (7%). For uBlock we did not witness any signi(cid:27)cant increase for suspicious domains; but we did notice an increase for Twitter widgets from 11% to 20% of the webpages. Our preliminary (cid:27)ndings indicate that though ad-blockers block external ads and third party trackers to varying degrees, they intro- duce various tracking services of their own. This is a novel (cid:27)nding and has potential impact on users privacy. We leave a detailed analysis on this for future work. Conclusions This paper provides a (cid:27)rst look at the performance and privacy aspects of popular ad-blocking tools. Based on our analysis, we conclude that (i) uBlock has the best performance, in terms of ad and third party tracker (cid:27)ltering, and least privacy tracking, (ii) The time to load pages is not necessarily faster when using adblockers, and (iii) this is partly the case due to additional trackers and libraries introduced by the adblocking tools. As ad- blockers try to monetise their business by selling ads themselves, our datasets and (cid:27)ndings could be used (i) by users, to get an idea on which adblocker to choose, from an increasingly competitive set of providers, and (ii) by researchers, as building blocks for further analysis on privacy and tracking behaviors by ad-blocking tools. Acknowledgements. This work has been supported by the Acad- emy of Finland project "Nestor" (286211) and the EC H2020 RIA project "SoBigData" (654024). REFERENCES [1] Paul Barford, Igor Canadi, Darja Krushevskaja, Qiang Ma, and S Muthukrishnan. 2014. Adscape: Harvesting and analyzing online display ads. In WWW. 597–608. [2] David S Evans. 2008. The economics of the online advertising industry. Review [12] Zhonghao Yu, Sam Macbeth, Konark Modi, and Josep M Pujol. 2016. Tracking Not) Doing. In HotWeb. 72–77. the Trackers. In WWW. 121–132. of network economics 7, 3 (2008). [3] Marjan Falahrastegar, Hamed Haddadi, Steve Uhlig, and Richard Mortier. 2014. Anatomy of the third-party web tracking ecosystem. arXiv preprint arXiv:1409.1066 (2014). [4] Matthew Malloy, Mark McNamara, Aaron Cahn, and Paul Barford. 2016. Ad Blockers: Global Prevalence and Impact. In Proceedings of the 2016 ACM on Internet Measurement Conference. 119–125. [5] Rishab Nithyanand and others. 2016. Ad-Blocking and Counter Blocking: A Slice of the Arms Race. arXiv:1605.05077 (2016). [6] PageFair. 2015. The 2015 Ad Blocking Report. https://blog.pagefair.com/2015/ad- blocking-report/ (2015). [7] PageFair. 2016. https://pagefair.com/blog/2016/mobile-adblocking-report/ (2016). [8] Enric Pujol, Oliver Hohlfeld, and Anja Feldmann. 2015. Annoyed Users: Ads and The 2016 Mobile Ad Blocking Report. Ad-Block Usage in the Wild. In IMC. 93–106. [9] Sebastian Schelter and Jérôme Kunegis. 2016. On the Ubiquity of Web Tracking: Insights from a Billion-Page Web Crawl. arXiv preprint arXiv:1607.07403 (2016). [10] Robert J Walls, Eric D Kilmer, Nathaniel Lageman, and Patrick D McDaniel. 2015. Measuring the Impact and Perception of Acceptable Advertisements. In IMC. 107–120. [11] Craig E Wills and Doruk C Uzunoglu. 2016. What Ad Blockers Are (and Are
1809.09331
2
1809
2018-09-26T04:11:21
Early Identification of Pathogenic Social Media Accounts
[ "cs.SI", "cs.AI", "cs.LG" ]
Pathogenic Social Media (PSM) accounts such as terrorist supporters exploit large communities of supporters for conducting attacks on social media. Early detection of these accounts is crucial as they are high likely to be key users in making a harmful message "viral". In this paper, we make the first attempt on utilizing causal inference to identify PSMs within a short time frame around their activity. We propose a time-decay causality metric and incorporate it into a causal community detection-based algorithm. The proposed algorithm is applied to groups of accounts sharing similar causality features and is followed by a classification algorithm to classify accounts as PSM or not. Unlike existing techniques that take significant time to collect information such as network, cascade path, or content, our scheme relies solely on action log of users. Results on a real-world dataset from Twitter demonstrate effectiveness and efficiency of our approach. We achieved precision of 0.84 for detecting PSMs only based on their first 10 days of activity; the misclassified accounts were then detected 10 days later.
cs.SI
cs
Early Identification of Pathogenic Social Media Accounts Hamidreza Alvari, Elham Shaabani, Paulo Shakarian Arizona State University Tempe, USA {halvari, eshaaban, shak}@asu.edu 8 1 0 2 p e S 6 2 ] I S . s c [ 2 v 1 3 3 9 0 . 9 0 8 1 : v i X r a Abstract -- Pathogenic Social Media (PSM) accounts such as terrorist supporters exploit large communities of supporters for conducting attacks on social media. Early detection of these accounts is crucial as they are high likely to be key users in making a harmful message "viral". In this paper, we make the first attempt on utilizing causal inference to identify PSMs within a short time frame around their activity. We propose a time-decay causality metric and incorporate it into a causal community detection-based algorithm. The proposed algorithm is applied to groups of accounts sharing similar causality features and is followed by a classification algorithm to classify accounts as PSM or not. Unlike existing techniques that take significant time to collect information such as network, cascade path, or content, our scheme relies solely on action log of users. Results on a real-world dataset from Twitter demonstrate effectiveness and efficiency of our approach. We achieved precision of 0.84 for detecting PSMs only based on their first 10 days of activity; the misclassified accounts were then detected 10 days later. Index Terms -- Causal inference, community detection, pathogenic social media accounts, early identification I. INTRODUCTION The unregulated nature and rapid growth of the Web have raised numerous challenges, including hate speech [1], human trafficking [2] and disinformation spread [3] which ultimately pose threats to users privacy [4], [5]. Take disinformation spread as an example where "Pathogenic Social Media" (PSM) accounts (e.g., terrorist supporters, or fake news writers) [3] seek to promote or degrade certain ideas by utilizing large on- line communities of supporters to reach their goals. Identifying PSMs has applications including countering terrorism [6], [7], fake news detection [8], [9] and water armies detection [10]. Early detection of PSMs in social media is crucial as they are likely to be key users to malicious campaigns [11]. This is a challenging task for three reasons. First, these platforms are primarily based on reports they receive from their own users1 to manually shut down PSMs which is not a timely approach. Despite efforts to suspend these accounts, many of them simply return to social media with different accounts. Second, the available data is often imbalanced and social network structure, which is at the core of many techniques [12] -- [15], is not readily available. Third, PSMs often seek to utilize U.S. Provisional Patent 62/628,196. Contact [email protected] for licensing information. 1https://bit.ly/2Dq5i4M 978-1-5386-7848-0/18/$31.00 2018 IEEE and cultivate large number of online communities of passive supporters to spread as much harmful information as they can. Present Work. Causal inference is tailored to identify PSMs since they are key users in making a harmful message "viral" -- where "viral" is defined as an order-of-magnitude increase. We propose time-decay causal metrics to distinguish PSMs from normal users within a short time around their activity. Our metrics alone can achieve high classification performance in identification of PSMs soon after they perform actions. Next, we pose the following research question: Are causality scores of users within a community higher than those across different communities? We propose a causal community detection-based classification method (C2DC), that takes causality of users and the community structure of their action log. Contributions. We make the following major contributions: • We enrich the causal inference framework of [16] and present time-decay extensions of the causal metrics in [3] for early identification of PSMs. • We investigate the role of community structure in early detection of PSMs, by demonstrating that users within a community establish stronger causal relationships com- pared to the rest. • We conduct a suit of experiments on a dataset from Twitter. Our metrics reached F1-score of 0.6 in identi- fying PSMs, half way their activity, and identified 71% of PSMs based on first 10 days of their activity, via supervised settings. The community detection approach achieved precision of 0.84 based on first 10 days of users activity; the misclassified accounts were identified based on their activity of 10 more days. II. BACKGROUND A. Technical Preliminaries Following the convention of [17], we assume an action log A of the form Actions(User,Action,Time), which contains tuples (u, au, tu) indicating that user u has performed action au at time tu. For ease of exposition, we slightly abuse the notation and use the tuple (u, m, t) to indicate that user u has posted (tweeted/retweeted) message m at time t. For a given message m we define a cascade of actions as Am = {(u, m(cid:48), t) ∈ Am(cid:48) = m}. User u is said to be an m-participant if there exists tu such that (u, m, tu) ∈ A. For users who have adopted a message in the early stage of its life span, we define key users as follows. Definition 1 (Key Users). Given message m, m-participant u and cascade Am, we say user u is a key user iff user u precedes at least φ fraction of other m-participants where φ ∈ (0, 1). In other words, Am × φ ≤ {j∃t(cid:48) : (j, m, t(cid:48)) ∈ A ∧ t < t(cid:48)}, where . is the cardinality of a set. Next, we define viral messages as follows. Definition 2 (Viral Messages). Given a threshold θ, we say a message m ∈ M is viral iff Am ≥ θ. We denote a set of all viral messages by Mvir. The prior probability of a message going viral is ρ = Mvir/M. The probability of a message going viral given key user u has participated in, is computed as follows: ρu = {mm ∈ Mvir ∧ u is a key user} {mm ∈ M ∧ u is a key user} (1) The probability that key users i and j tweet/retweet message m chronologically and make it viral, is computed as: pi,j = {m ∈ Mvir∃t, t(cid:48) : t < t(cid:48) ∧ (i, m, t), (j, m, t(cid:48)) ∈ A} {m ∈ M∃t, t(cid:48) : t < t(cid:48) ∧ (i, m, t), (j, m, t(cid:48)) ∈ A} (2) To examine how causal user i was in helping a message m going viral, we shall explore what will happen if we exclude user i from m. We define the probability that only key user j has made a message m viral, i.e. user i has not posted m or does not precede j as: p¬i,j = {m ∈ Mvir∃t(cid:48) : (j, m, t(cid:48)) ∈ A ∧ (cid:64)t : t < t(cid:48), (i, m, t) ∈ A} {m ∈ M∃t(cid:48) : (j, m, t(cid:48)) ∈ A ∧ (cid:64)t : t < t(cid:48), (i, m, t) ∈ A} (3) Next, we adopt the notion of Prima Facie causes [18]: Definition 3 (Prima Facie Causal Users). A user u is said to be Prima Facie causal user for cascade Am iff: (1) user u is a key user of m, (2) m ∈ Mvir, and (3) ρu > ρ. We borrow the concept of related users from a rule-based system [19] which was an extension to the causal inference framework in [16]. We say users i and j are m-related if (1) both are Prima Facie causal for m, and (2) i precedes j. We then define a set of user i's related users as R(i) = {jj (cid:54)= i and i, j are m-related}. B. Dataset We collect a dataset (Table I) of 53M ISIS related tweets/retweets in Arabic, from Feb 22, 2016 to May 27, 2016. The dataset has different fields including user ID, retweet ID, hashtags, content, posting time. The tweets were collected using 290 different hashtags such as #Terrorism and #StateOfTheIslamicCaliphate. We use a subset of this dataset which contains 35K cascades of different sizes and durations. There are ∼2.8M tweets/retweets associated with the cascades. After pre-processing and removing duplicate users from cascades, cascades sizes (i.e. number of associated postings) vary between 20 to 9,571 and take from 10 seconds to 95 days to finish. The log-log distribution of cascades vs. cascade size and the cumulative distribution of duration of cascades are depicted in Figure 1. TABLE I DESCRIPTION OF THE DATASET. Name # of Cascades # of Viral Cascades # of Tweets/Retweets # of Users Value 35K 6,602 2,808,878 Suspended 64,484 Active 536,609 Based on the content of tweets in our dataset, PSMs are terrorism-supporting accounts who have participated in viral cascades. We chose to use θ = 100 and take ∼6K viral cascades with at least 100 tweets/retweets. We demonstrate number of PSMs that have been suspended by the Twitter over time and total number of suspended users in each cascade, in Figure 1. We experiment the effectiveness of our proposed approach on subsets of the training set with different sizes. Note we use no more than 50% of original dataset to ensure our approach is able to identify PSMs early enough. The dataset does not have any underlying network. We only focus on the non-textual information in the form of an action log. We set φ = 0.5 to select key users and after the data collection, we check through Twitter API whether they have been suspended (PSM) or they are active (normal) [20]. According to Table I, 11% of the users in our dataset are PSM and others are normal. C. Causal Measures Causal inference framework was first introduced in [16]. Later, [3] adopted the framework and extended it to suite the problem of identifying PSMs. They extend the Kleinberg- Mishra causality (K&M ) to a series of causal metrics. To recap, we briefly explain them in the following discussion. Before going any further, K&M is computed as follows: (cid:80) j∈R(i)(pi,j − p¬i,j) R(i) K&M (i) = (4) This metric measures how causal user i is, by taking the average of pi,j − p¬i,j over R(i). The intuition here is user i is more likely to be cause of message m to become viral than user j, if pi,j − p¬i,j > 0. The work of [3] devised a suit of the variants, namely relative likelihood causality (rel), neighborhood-based causality (nb) and its weighted version (wnb). Note that none of these metrics were originally introduced for early identification of PSMs. Therefore, we shall make slight modifications to their notations to adjust our temporal formulations, using calligraphic uppercase letters. We define EK&M over a given time interval I as follows: (cid:80) j∈R(i)(Pi,j − P¬i,j) E I K&M (i) = R(i) (5) where R(i), Pi,j, and P¬i,j are now defined over I. Authors in [3] mention that this metric cannot spot all PSMs. They define another metric, relative likelihood causality Erel, which works by assessing relative difference between Pi,j, and P¬i,j. We use its temporal version over I, E I rel(i) = S(i,j) R(i). Fig. 1. Left to right: Log-log distribution of cascades vs. cascade size. Cumulative distribution of duration of cascades. Number of inactive users in different subsets of the training set. Total inactive users in each cascade. F1-SCORE RESULTS FOR PSM ACCOUNTS USING EACH CAUSAL METRIC TABLE II IN [3]. Metric F1-score E I K&M 0.41 E I 0.3 rel E I 0.49 E I 0.51 10% 20% 30% 40% 50% 0.49 0.37 0.55 0.59 0.45 0.33 0.52 0.55 0.46 0.35 0.54 0.56 0.42 0.31 0.51 0.52 nb wnb Fig. 2. An illustration of how decay-based causality works. To compute ξI k(i) over I = [t0, t], we use a sliding window ∆ = [t(cid:48)−δ, t(cid:48)] and take the average between the resultant causality scores e−σ(t−t(cid:48)) × E ∆ k (i). where S(i, j) is defined as follows and α is infinitesimal: (cid:40) Pi,j P¬i,j +α − 1, Pi,j > P¬i,j 1 − P¬i,jPi,j Pi,j ≤ P¬i,j , S(i, j) = (6) K&M (i) (cid:80) i∈Q(j) E I Q(j) Two other neighborhood-based metrics were also defined in [3], whose temporal variants are computed over I as E I , where Q(j) = {ij ∈ R(i)} is nb(j) = the set of all users that user j belongs to their related users sets. Similarly, the second metric is a weighted version of the above metric and is called weighted neighborhood-based causality and is calculated as E I K&M (i) . This is to capture different impacts that users in Q(j) have on user j. We apply a threshold-based selection approach that selects PSMs from normal users, based on a given threshold. Following [3], we use a threshold of 0.7 for all metrics except E I rel for which we used a threshold of 7 (Table II). (cid:80) i∈Q(j) wi×E I i∈Q(j) wi wnb(j) = (cid:80) III. THE PROPOSED FRAMEWORK A. Leveraging Temporal Aspects of Causality Previous causal metrics do not take into account time-decay effect. They assume a steady trend for computing causality scores. This is an unrealistic assumption, as causality of users may change over time. We introduce a generic decay-based metric. Our metric assigns different weights to different time points of a given time interval, inversely proportional to their distance from t (i.e., smaller distance is associated with higher weight). Specifically, it performs the following: it (1) breaks down the given time interval into shorter time periods using a sliding time window, (2) deploys an exponential decay function of the form f (x) = e−αx to account for the time- decay effect, and (3) takes average of the causality values computed over each sliding time window. Formally, ξI k is defined as follows, where k ∈ {K&M, rel, nb, wnb}: ξI k(i) = 1 T −σ(t−t(cid:48)) × E ∆ e k (i) (7) (cid:88) t(cid:48)∈T where σ is a scaling parameter of the exponential decay function, T = {t(cid:48)t(cid:48) = t0 + j × δ, j ∈ N ∧ t(cid:48) ≤ t − δ} is a sequence of sliding-time windows, and δ is a small fixed amount of time, which is used as the length of each sliding- time window ∆ = [t(cid:48)−δ, t(cid:48)] (Figure 2). To apply the threshold- based approach, we once again use a threshold of 0.7 for all metrics except ξI rel for which we used a threshold of 7 (Table III). Early Detection of PSMs. Given action log A, and user u where ∃t s.t. (u, m, t) ∈ A, our goal is to determine if u's account shall be suspended given its causality vector xu ∈ Rd (here, d = 4) computed using any of the causality metrics over [t − δ, t + δ]. B. Leveraging Community Structure Aspects of Causality To answer the research question posed earlier, since net- work structure is not available, we need to build a graph G = (V, E) from A by connecting any pairs of users who have posted same message chronologically. In this graph, V is a set of vertices (i.e. users) and E is a set of directed edges between users. For the sake of simplicity and without loss of generality, we make the edges of this graph undirected. Next, we leverage the LOUVAIN algorithm [21] to find the partitions C = {C1, C2, ..., Ck} of k communities over G. Among a myriad of the community detection algorithms [22] -- [24], we chose LOUVAIN due to its fast runtime and scalability -- we leave examining other community detection algorithms to future work. Next, we perform the two-sample t-test H0 : va ≥ vb, H1 : va < vb. The null hypothesis is: users in a given community establish weak causal relations with each other as opposed to the other users in other communities. We construct two vectors va and vb as follows. We create va 101102103104105Cascades Size10-1100101102103104# of Cascades0123456789Duration of Cascade (s)1e60.00.51.01.52.02.53.03.5# of Cascades1e410%20%30%40%50%Percentage of Training200040006000800010000120001400016000# of inactive users0.00.51.01.52.02.53.03.5Cascade1e401234567# of inactive users1e4 F1-SCORE RESULTS FOR PSM ACCOUNTS USING EACH DECAY-BASED METRIC WITH AND WITHOUT COMMUNITIES. TABLE III Metric ξI K&M ξI rel ξI nb ξI wnb F1-score (without/with communities) 10% 0.44/0.49 0.36/0.4 0.52/0.56 0.54/0.57 20% 0.46/0.51 0.38/0.43 0.53/0.57 0.55/0.58 30% 0.47/0.52 0.39/0.46 0.54/0.58 0.57/0.6 40% 0.5/0.54 0.41/0.49 0.56/0.6 0.58/0.62 50% 0.53/0.57 0.42/0.5 0.59/0.61 0.6/0.63 Fig. 3. Left to right: distributions of active and inactive users using communities and ξI k when k ∈ {K&M, rel, nb, wnb}. size(cid:80)C by computing Euclidean distances between causality vectors (cid:80)C (xi, xj) corresponding to each pair of users (ui, uj) who are from same community Cl ∈ C. Therefore, va contains l=1 Cl.(Cl − 1) elements. We construct vb of exactly 1 2 l=1 Cl by computing Euclidean distance between each in community Cl ∈ C, and a random user uk user ui chosen from the rest of the communities, i.e., C \ Cl. The null hypothesis is rejected at significance level α = 0.01 with the p-value of 4.945e-17. We conclude that users in same communities are more likely to establish stronger causal relationships with each other than the rest of the communities. The answer to the question is thus positive. For brevity, we only reported results for 10% of the training set, while making similar arguments for other percentages is straightforward. Figure 3 shows box plots of the distributions of users using the decay-based metrics and the communities and same set of thresholds as before. We observe a clear distinction between active/suspended accounts, using the community structure. Results in Table III show improvements over previous ones. i do i ∈ C(cid:48) 1, ..., x(cid:48) n}, G, k n} 1, ..., y(cid:48) Algorithm 1 Causal Community Detection-Based Classifi- cation Algorithm (C2DC) Require: Training samples {x1, ..., xN} , tests {x(cid:48) Ensure: Predicted labels {y(cid:48) 1: C ← LOUVAIN(G) 2: for each x(cid:48) Cl ← C(cid:48) ∈ C s.t. x(cid:48) 3: D ← {} 4: for each xj ∈ Cl do 5: dij ← x(cid:48) i − xj2 6: D ← D ∪ {dij} 7: 8: 9: 10: 11: end for end for K ← KNN(D, k) i ← DOMINANT-LABEL(K) y(cid:48) First step of the proposed algorithm (Algorithm 1) involves finding the communities. In the second step, each unlabeled user is classified based on the available labels of her nearby peers in the same community. We use the K-NEAREST NEIGHBORS (KNN) algorithm to compute her k nearest neigh- bors in the same community, based on Euclidean distances between their causality vectors. We label her based on the majority class of her k nearest neighbors in the community. The merit of using community structure over merely using KNN is, communities can give finer-grained and more accurate sets of neighbors sharing similar causality scores. IV. EXPERIMENTS We use different subsets of size x% of the entire time-line (from Feb 22, 2016 to May 27, 2016) of the action log A, by varying x as {10, 20, 30, 40, 50}. For each subset and user i in the subset, we compute feature vector xi ∈ R4 of the corresponding causality scores. The feature vectors are then fed into supervised classifiers and the community detection- based algorithm. For the sake of fair comparison, we perform this for both causal and decay-based metrics. For both metrics, we empirically found that ρ = 0.1 and α = 0.001 work well. For the decay-based causality metric we shall also assume a sliding window of size of 5 days (i.e. δ = 5) and set σ = 0.001 which were found to work well in our experiments. Note we only present results for PSMs. Among many other supervised classifiers such as ADABOOST , LOGISTIC REGRESSION and SUPPORT VECTOR MACHINES (SVM), RANDOM FOREST (RF) with 200 estimators and 'entropy' criterion, achieved the best performance. Therefore, for brevity we only report results when RF is used as the classifier. We present results for the proposed community detection- based framework and causal and decay-based metrics. For computing k nearest neighbors, we set k = 10 as it was found to work well for our problem. By reporting the results of KNN trained on the decay-based causality features, we stress that using KNN alone does not yield a good performance. For the sake of fair comparison, all approaches were implemented 10%20%30%40%50%Percentage of Training0.00.51.01.52.02.5Causality ScoreK&MInactiveActive10%20%30%40%50%Percentage of Training05101520Causality ScorerelInactiveActive10%20%30%40%50%Percentage of Training0.00.51.01.52.0Causality ScorenbInactiveActive10%20%30%40%50%Percentage of Training0.00.51.01.52.0Causality ScorewnbInactiveActive and run in Python 2.7x, using the scikit-learn package. For any approach that requires special tuning of parameters, we conducted grid search to choose the best set of parameters. A. Baseline Methods 1) CAUSAL [3]: We compare our metrics against the ones in [3] via supervised and community detection settings. 2) SENTIMETRIX-DBSCAN [25]: This was the winner of the DARPA challenge. It uses several features such as tweet syntax (e.g., average number of hashtags, average number of links), tweet semantics (e.g., LDA topics), and user behavior (e.g., tweet frequency). We perform 10-fold cross validation and use a held-out test set for evaluation. This baseline uses a seed set of 100 active and 100 inactive accounts, and then use DBSCAN clustering algorithm to find the associated clusters. Available labels are propagated to nearby unlabeled users in each cluster based on the Euclidean distance metric, and labels of the remaining accounts are predicted using SVM. 3) SENTIMETRIX-RF: This is a variant of [25] where we excluded the DBSCAN part and instead trained RF classifier using only the above features to evaluate the feature set. B. Identification of PSM Accounts For each subset a separate 10-fold cross validation was performed (Figure 4). We observe the following: • Community detection achieves the best performance us- ing several metrics. This aligns well with the t-test results discussed earlier: taking into account community structure of PSMs can boost the performance. • Causal and decay-based metrics mostly achieve higher performance than other approaches via both settings. • Decay-based metrics are effective at identifying PSMs at different intervals via both settings. This lies at the inher- ent difference between decay-based and causal metrics -- our metrics take into account time-decay effect. • Although both variants of SENTIMETRIX-DBSCAN use many features, they were unable to defeat our approach. C. Timeliness of PSM Accounts Identification For each approach, we would like to see how many of PSMs who were active in the first 10 days of the dataset, are correctly classified (i.e., true positives) as time goes by. Also, we need to keep track of false positives to ensure given approach does not merely label each instance as positive -- otherwise a trivial approach that always label each instance as PSM would achieve highest performance. We are also interested to figure how many days need to pass to find these accounts. We train each classifier using 50% of the first portion of the dataset, and use a held-out set of the rest for evaluation. Next, we pass along the misclassified PSMs to the next portions to see how many of them are captured over time. We repeat the process until reaching 50% of the dataset -- each time we increase the training set by adding new instances of the current portion. There are 14,841 users in the first subset from which 3,358 users are PSMs. Table IV shows the number of users from the first portion that (1) are correctly classified as PSM (out of 3,358), (2) are incorrectly classified as PSM (out of 29,617), over time. Community detection approaches were able to detect all PSMs who were active in the first 10 days of our dataset, no later than a month from their first activity. DECAY- C2DC, identified all of these PSMs in about 20 days since the first time they posted a message. Also, both causal and decay-based metrics when fed to RF classifier, identified all of the PSMs in the first period. SENTIMETRIX-DBSCAN and SENTIMETRIX-RF failed to detect all PSMs from the first portion, even after passing 50 days since their first activity. Furthermore, these two baselines generated much higher rates of false positives compared to the rest. The observations we make here are in line with the previous ones: the proposed community detection-based framework is more effective and efficient than the rivals. V. RELATED WORK Social Spam/Bot Detection. Recently, DARPA organized a Twitter bot challenge to detect "influence bots" [25]. The work of [26], used similarity to cluster accounts and uncover groups of malicious users. The work of [27] presented a supervised framework for bot detection which uses more than thousands features. Our work does not deploy any types user related attributes. For a comprehensive survey on the ongoing efforts to fight social bots, we direct the reader to [28]. Fake News Identification. A growing body of research is addressing the impact of bots in manipulating political dis- cussion, including the 2016 U.S. presidential election [29] and the 2017 French election [30]. For example, [29] analyzes tweets following recent U.S. presidential election and found evidences that bots played key roles in spreading fake news. Extremism Detection. The work of [7] designed a behavioral model to detect extremists. Authors in [31] performed iterative vertex clustering and classification to identify Islamic Jihadists on Twitter. Our work also differs from these works as we do not use network/user attributes. Detection of Water Armies. Works of [10], [32] used user be- havioral and domain-specific attributes to detect water armies. Causal Reasoning. As opposed to [16], [19], [33] which deal with preconditions as single atomic propositions, we use rules with preconditions of more than one atomic propositions. Also, neither of [3], [16] have addressed early detection of PSMs. VI. CONCLUSION We enriched the existing causal inference framework to suite the problem of early identification of PSMs. We proposed time-decay causal metrics which reached F1-score of 0.6 and via supervised learning identified 71% of the PSMs from the first 10 days of the dataset. We proposed a causal community detection-based classification algorithm, by leveraging com- munity structure of PSMs and their causality. We achieved the precision of 0.84 for detecting PSMs within 10 days around their activity; the misclassified accounts were then detected 10 days later. Our future plan includes exploring other community detection algorithms and other forms of causal metrics. Fig. 4. Precision, recall, F1-score and AUC results for each classifier. Experiments were run using 10-fold cross validation. TRUE/FALSE POSITIVES FOR PSM ACCOUNTS. NUMBERS ARE OUT OF 3,358/29,617 PSM/NORMAL ACCOUNTS FROM THE FIRST PERIOD. LAST COLUMN SHOWS THE NUMBER OF PSM ACCOUNTS FROM THE FIRST PERIOD WHICH WERE NOT CAUGHT. TABLE IV Learner True Positives/False Positives Remaining 03/02-03/12 03/12-03/22 03/22-03/31 DECAY-C2DC CAUSAL-C2DC DECAY-KNN DECAY-RF CAUSAL-RF SENTIMETRIX-RF SENTIMETRIX-DBSCAN 02/22-03/02 3,072/131 3,065/156 2,198/459 2,472/307 2,398/441 2,541/443 2,157/2,075 286/0 188/20 427/234 643/263 619/315 154/0 551/5,332 0/0 105/0 315/78 143/121 221/169 93/0 271/209 0/0 0/0 109/19 72/68 89/70 25/0 92/118 03/31-04/09 0/0 0/0 96/0 28/0 51/0 14/0 72/696 0 0 213 0 0 531 215 VII. ACKNOWLEDGMENTS This work was supported through DoD Minerva program. REFERENCES [1] P. Badjatiya, S. Gupta, M. Gupta, and V. Varma, "Deep learning for hate speech detection in tweets," in Proceedings of WWW, 2017. [2] H. Alvari, P. Shakarian, and J. K. Snyder, "Semi-supervised learning for detecting human trafficking," Security Informatics, vol. 6, no. 1, p. 1, 2017. [3] E. Shaabani, R. Guo, and P. Shakarian, "Detecting pathogenic social media accounts without content or network structure," in ICDIS, 2018. [4] G. Beigi, K. Shu, Y. Zhang, and H. Liu, "Securing social media user data: An adversarial approach," in Proceedings of the 29th on Hypertext and Social Media. ACM, 2018, pp. 165 -- 173. [5] G. Beigi and H. Liu, "Privacy in social media: Identification, mitigation and applications," arXiv preprint arXiv:1808.02191, 2018. [6] M. Khader, Combating Violent Extremism and Radicalization in the Digital Era, ser. Advances in Religious and Cultural Studies, 2016. [7] J. Klausen, C. Marks, and T. Zaman, "Finding online extremists in social networks," CoRR, vol. abs/1610.06242, 2016. [8] A. Gupta, P. Kumaraguru, C. Castillo, and P. Meier, TweetCred: Real- Time Credibility Assessment of Content on Twitter, 2014. [9] A. Gupta, H. Lamba, and P. Kumaraguru, "$1.00 per rt #bostonmarathon #prayforboston: Analyzing fake content on twitter," 2013. [10] C. Chen, K. Wu, S. Venkatesh, and X. Zhang, "Battling the internet water army: Detection of hidden paid posters," CoRR, 2011. [11] O. Varol, E. Ferrara, F. Menczer, and A. Flammini, "Early detection of promoted campaigns on social media," EPJ Data Science, 2017. [12] L. Weng, F. Menczer, and Y.-Y. Ahn, "Predicting successful memes using network and community structure." in ICWSM, 2014. [17] A. Goyal, F. Bonchi, and L. V. Lakshmanan, "Learning influence probabilities in social networks," in WSDM, 2010. [18] P. Suppes, "A probabilistic theory of causality," 1970. [19] A. Stanton, A. Thart, A. Jain, P. Vyas, A. Chatterjee, and P. Shakarian, "Mining for causal relationships: A data-driven study of the islamic state," CoRR, 2015. [20] K. Thomas, C. Grier, D. Song, and V. Paxson, "Suspended accounts in retrospect: an analysis of twitter spam," in ACM SIGCOMM conference on Internet measurement conference, 2011. [21] V. D. Blondel, J.-L. Guillaume, R. Lambiotte, and E. Lefebvre, "Fast unfolding of communities in large networks," Journal of Statistical Mechanics: Theory and Experiment, 2008. [22] H. Alvari, A. Hajibagheri, G. Sukthankar, and K. Lakkaraju, "Identifying community structures in dynamic networks," Social Network Analysis and Mining, vol. 6, no. 1, p. 77, 2016. [23] A. Lancichinetti, F. Radicchi, J. J. Ramasco, and S. Fortunato, "Finding statistically significant communities in networks," PloS one, vol. 6, no. 4, p. e18961, 2011. [24] H. Alvari, S. Hashemi, and A. Hamzeh, "Detecting overlapping com- munities in social networks by game theory and structural equivalence concept," in International Conference on Artificial Intelligence and Computational Intelligence. Springer, 2011, pp. 620 -- 630. [25] V. S. Subrahmanian, A. Azaria, S. Durst, V. Kagan, A. Galstyan, K. Lerman, L. Zhu, E. Ferrara, A. Flammini, and F. Menczer, "The darpa twitter bot challenge," 2016. [26] Q. Cao, X. Yang, J. Yu, and C. Palow, "Uncovering large groups of active malicious accounts in online social networks," in CCS, 2014. [27] O. Varol, E. Ferrara, C. A. Davis, F. Menczer, and A. Flammini, "Online interactions: Detection, estimation, and characterization," human-bot ICWSM, 2017. [28] E. Ferrara, O. Varol, C. Davis, F. Menczer, and A. Flammini, "The rise of social bots," Communications of the ACM, 2016. [13] D. Kempe, J. Kleinberg, and E. Tardos, "Maximizing the spread of [29] C. Shao, G. L. Ciampaglia, O. Varol, A. Flammini, and F. Menczer, influence through a social network," in KDD, 2003. [14] G. Beigi and H. Liu, "Similar but different: Exploiting users' congruity for recommendation systems," in International Conference on Social Computing, Behavioral-Cultural Modeling, and Prediction. Springer, 2018. [15] X. Zhang, J. Zhu, Q. Wang, and H. Zhao, "Identifying influential nodes in complex networks with community structure," Know.-Based Syst., vol. 42, 2013. [16] S. Kleinberg and B. Mishra, "The temporal logic of causal structures," UAI, 2009. "The spread of fake news by social bots," 2017. [30] E. Ferrara, "Disinformation and social bot operations in the run up to the 2017 french presidential election," 2017. [31] M. C. Benigni, K. Joseph, and K. M. Carley, "Online extremism and the communities that sustain it: Detecting the isis supporting community on twitter," PloS one, 2017. [32] K. Wang, Y. Xiao, and Z. Xiao, "Detection of internet water army in social network," 2014. [33] S. Kleinberg, "A logic for causal inference in time series with discrete and continuous variables," in IJCAI, 2011.
1310.1249
1
1310
2013-10-04T13:04:45
Reading Stockholm Riots 2013 in social media by text-mining
[ "cs.SI", "cs.CL", "physics.soc-ph", "stat.AP" ]
The riots in Stockholm in May 2013 were an event that reverberated in the world media for its dimension of violence that had spread through the Swedish capital. In this study we have investigated the role of social media in creating media phenomena via text mining and natural language processing. We have focused on two channels of communication for our analysis: Twitter and Poloniainfo.se (Forum of Polish community in Sweden). Our preliminary results show some hot topics driving discussion related mostly to Swedish Police and Swedish Politics by counting word usage. Typical features for media intervention are presented. We have built networks of most popular phrases, clustered by categories (geography, media institution, etc.). Sentiment analysis shows negative connotation with Police. The aim of this preliminary exploratory quantitative study was to generate questions and hypotheses, which we could carefully follow by deeper more qualitative methods.
cs.SI
cs
Reading Stockholm Riots 2013 in social media by text-mining Andrzej Jarynowski1,2,3, Amir Rostami1 1) Department of Sociology, Stockholm University, Stockholm, Sweden 2) Department of Theory of Complex System, Smoluchowski Institute, Jagiellonian University, Cracow, Poland 3) Laboratory of Technics of Virtual Reality, CIOP – National Research Instutute, Warsaw, Poland [email protected] Abstract The riots in Stockholm in May 2013 were an event that reverberated in the world media for its dimension of violence that had spread through the Swedish capital. In this study we have investigated the role of social media in creating media phenomena via text mining and natural language processing. We have focused on two channels of communication for our analysis: Twitter and Poloniainfo.se (Forum of Polish community in Sweden). Our preliminary results show some hot topics driving discussion related mostly to Swedish Police and Swedish Politics by counting word usage. Typical features for media intervention are presented. We have built networks of most popular phrases, clustered by categories (geography, media institution, etc.). Sentiment analysis shows negative connotation with Police. The aim of this preliminary exploratory quantitative study was to generate questions and hypotheses, which we could carefully follow by deeper more qualitative methods. Keywords: text-mining, cyberemotions, social networks, riots, sentiment analysis, language semantics 1. Introduction The language and its products are the most important source of information of people’s states of mind in communication process (Babtist 2010). The semantic and structural analysis of texts could shed more light on human perception, interpretation and creation of social phenomena like riots. Moreover, thinking in terms of networks and hierarchy (associations between words and terms) has gained ground in many disciplines (Mouge 2003), including psychology, criminology, anthropology, political science, while it has risen from physics and sociology. Our aim is to provide qualitative analysis of how people discuss Stockholm riots and what are their stimuli to such activity. To do so, we investigate Forum posts (Poloniainfo.se) and Twitter during and after riots. We choose those datasets, because, they are freely available and can be legally crawled from Internet and both can be treated as big data. Unfortunately, both Medias represent bias, due to very special category of people using them, and conclusions based on those communities cannot be directly generalize for the whole population. However, some insights for future studies could be obtained, especially from Twitter (Polonia.info is even less representative and findings from there could only help us to understand the complexity of riot phenomena). The scientific community has already experienced the power of social network media since the riots in Tottenham, north London, in August 2011 (theguardian&LSE 2011). Since then Twitter and any other social media were carefully investigated for almost every as STOP-ACTA such social movement (Jarynowski 2013) or Smoleńsk crash (Sobkowicz 2013) in Poland with computational tools constructed for this problem. We try some simple tools of NLP (natural language processing) and text-mining (Yuskiv 2006) to obtain some kind of hierarchical or network structure of concepts mentioned by Internet-users. The initial disturbances in Husby, a suburb in the northern part of Stockholm, were triggered by the police shooting of an old Maghreb-origin man. Most of the discussion took place during riots since 15.05 (incident with police) via period of actual riots 20-25.05 and shortly after that. Both Forum and Twitter data were collected from 15.05 till middle of July (15.07) so both data series are exactly 2 months long. With the relatively high standard of living in Sweden (even suburban area of Stockholm like Husby is a long way away from poorness), the economic grievances were probably not the primary motivating factor in these protests (Barker 2013). The riots in Stockholm have been carried out by a combination of angry local youths, radical left-wing activists and hardened criminals (Rostami 2012). Swedish Police have already intervened against many similar size riots like in Rosengård (Malmö) in 2009 or in other neighborhoods often gathered people with socio-economic problems (Nilson 2011). Criminologists note that the segregation issues, which have been driving riots in 20th century, turn in 21th into: alienation, rootlessness, unemployment, distrust and resentment against society (Hallsworth 2011). Our goal is longitudinal text-mining analyses of public opinion (within social media) on the riot in order to explain its phenomena theoretically described by criminologists, put some light on driving factors, which warm up the discourse and set up some hypothesis about emergence of media phenomena. 2. Twitter 2.1. Data description and objectives We analyze ~14k Tweets in different languages (mostly Swedish and English) tagged with hash Husby. That’s implying international perspective of people, who express their thoughts via Twitter. Because of Multilanguage perspective of such Tweets, we decide to analyze not whole content of those tweets, but only co -occurrence with other hash tags. We do not differentiate who was simple users, mainstream media, non- twitting: mainstream media, bloggers, activists, or even and the police. Only ~ 8k Tweets were taken in our analysis (only those with more than one hash tag). We choose the 20 most frequent tags, there Svpol is the most frequent with Sthlmriots and Migpol far behind and rest (Table 1). We decided to analyze hash tags, just as they are, but there could be possibility to categorize some hash tags in just one category (e.g. by combining Sthlmriots with Stkhlmriot). English meaning No Hash tag Swedish Politics 1 Svpol Sthlmriots 2 Sthlmriots Migration Politics 3 Migpol Sthlmriot 4 Sthlmriot 5 Stockholm Stockholm 6 Aftonbladet Press company Press company 7 Nymo District of Stockholm 8 Rinkeby Police 9 Polisen Sweden 10 Sweden Riots 11 Upplopp District of Stockholm 12 Kista Debate in Swedish TV 13 Svtdebatt Left Politics 14 Vpol Debate 15 Debatt Police PR Department 16 08pol 17 Expressentv TV Program Political Activists 18 Megafonen Riots 19 Kravaller District of Stockholm 20 Tensta Table 1: Most frequent tags Counts 3897 1319 436 236 200 142 124 109 108 100 92 89 82 80 76 75 72 71 70 69 2.2. Longitude analysis We found, that for example Svpol (Fig. 1) and Migpol (Fig. 2) are tags, which were in constant use for the whole period. The shape of cumulative hash tags counts curve for them is almost linear. That means: the occurrence probabilities are equal in time. Moreover, every second twit since beginning of riots till middle of July is associated with Svpol hash tag. The rest of the hash tags died out after riots finished. Fig. 1: Longitudinal analysis of two most frequent tags (Svpol, Stkhlmriots) Moreover, for tags like Debatt or Svtdebatt, we observed, that people used them only around the event (Fig. 2), which is a very common phenomena in Twitter world. Some media names hash tags have a stepwise shape like Nymo (Fig. 2), which also is characteristic for media. Those institutions provide some news, which are likely to be retwited. That explains the big number of media hash tag use in short time surrounded by quiet regions (Chmiel 2011). The frequency of usage of given media hash tags could be also an indicator of how influential that medium is. Fig. 2: Longitudinal analysis of rest of most frequent tags 2.3. Association analysis We also try to find assotiation between tags. We define the link, when in the same tweet both tags coexist. Hierarchical analysis shows leading role of dyad Svpol- Sthhlmriots (Fig. 3, Table 2). Moreover, 2-gram elements (co-occurrence of 2 terms in one twit) of main dual dyad sthlmriots_svpol and svpol_migpol are a few times more frequent than other elements (Table 2). However, we cannot call triangle Migpol, Svpol, Sthlmriots as triad, because the link between Migpol and Sthlmriots was observed only 37 times so it is an order of magnitude weaker than main double dyad . No Hash tag Counts 1 2 3 4 5 sthlmriots_svpol svpol_migpol svpol_sthlmriot migpol_nymo vpol_svpol 533 353 107 50 47 Table 2: The most frequent 2-grams. Evidence of importnace of dual dyad and sthlmriots_svpol svpol_migpol. Let’s define construction of the network (Fig. 3) . We decided to establish lower threshold on the level of 2 tweets, needed to create a link (everything below seems to be a noise, because link- association should be repeated at least once to avoid random effects). Thickness of the link corresponds to its weight (count of given 2 - gram). On the other hand, dual dyad sthlmriots_svpol and svpol_migpol thicknesses were reduced not to cover the whole figure. Cumulative hash tags count15.0515.07Tweets05001000150020002500300035004000Tags used svpol sthlmriotsCumulative hash tags count migpol sthlmriot stockholm aftonbladet nymo rinkeby polisen sweden upplopp kista svtdebatt vpol debatt 08pol expressentv megafonen kravaller tensta15.0515.07050100150200250300350400450Tags used compared Polish freq pronoun im 79 us 102 us tym describe problems of Husby citizens unlike their own perspective. interesting Polish freq pronoun nam 4 them nam - the nasze/ them/ nasz/ ours/ their/ nasza 2 our 72 ich theirs 1 my 53 we oni they - my 48 we ci these them nas 13 38 us nich Table 3: Orientation of conversation on „them” 3.2. Methodology and data mining We tried to categories words used in discussion in few categories. To do so, we choose only those words, which have only one clear meaning somehow related to the topic. We found 386 different words, which appear at least once in our sample and seem to have some important meaning. From them around 300 were attached to different categories 1-10 with subcategories described by some keywords (Table 4). Every category allocate sum of number of unique words, which belong to family of given keywords related to given category or subcategories. 1.1 Employment (work/employees, hardworking, rich, money, taxes) 1.2 Unemployment (unemployment, social help, poor) 2 Family (family) 3 Religion (Islam, religion) 4 Education (education, schools, learn, language) 5 Living (apartments/residents, district) 6.0 Politics-general (government, politicians, democracy) 6.1 Politics-multikulti (invite, acclimatization, multikulti politics, hope, tolerance, asylum, get, arrives) 6.2 Politics-segregation (racist names, eugenics, racism, segregation, deportation, hate) 7.0 Identity-general (nation, Stockholm, society) 7.1 They (immigrants, Arabian, other nations, origin) 7.2 Swedes (Swedes, Swedish, Sweden, Europe, nobility) 8.0 Police-general (police, military) 8.1 Police-induce (killed, wounds, induce, bullets, weapon, shoot, Police in slang, knife, disarm) 8.2 Police-law (law, cutthroat, action in the name of law) 9.0 Riots-general (throw, riots, night, street, violence, stones, car) 9.1 Riots-pro (rebellion, youth, protest, vulnerable) 9.2 Vandalism (fires, vandalism, aggression) 10 External fields (other riots, problems, wars, media) Table 4: Categories, subcategories and keywords describing them debate, party, Fig. 3: Network of connections (links thinness in dual dyad sthlmriots_svpol and svpol_migpol were decreased to see other links also) Network analysis (Buda 2013) show leading role of dyad Svpol-Sthhlmriots and quasi-triangle Migpol, Svpol, Sthlmriots. On the other hand we can find clusters of geographical districts, tags related to debate, Swedish words describing riots, and media institution. 2.4. Conclusions of Twitter analysis The provided analysis shows many features known already from other studies (stepwise functions for cumulative Tweets count for media organization or clusterization of hashes within similar semantic field) and general observation, but here they are presented in a more systematized way. The most important topic is politics. Svpol as other hashes with the same meaning, are definitively the most frequent hash tags. Moreover only Svpol and Migpol seem to be used after riots with the same frequency as before. It would be interesting to see how hashes about politics co-occurrence with others change with time. Another question could be asked with sentiment analysis: how emotionally oriented are hashes about politics. 3. Poloniainfo.se 3.1. Data description and objectives Internet Forums like poloniainfo.se are not broadcasting media as Twitter, but relations between users are usually stronger and more personal. Quantitative research could be deeper due to complex relations between users (Zbieg 2012), but on the other hand amount the of data is not as impressive as Twitter. We look at frequencies of world used by Forum user in Topic about Riots in 525 Posts. We choose only Polish words in this analysis. Firstly we found extremely huge amount of personal and possessive pronouns of third person in plural form (Table 3). Everything seems to be describing about “Them” more often called “others” in ethnological literature (Bauman 1996). “They” are native Swedes represented mostly by government and police and another “They”: riot participants. That indicates observative and little biased way of looking on the riots presented by Forum users (Gustafsson in press). The Polish community did not take part in riots, and on the other hand have no significant influence on politics of Sweden. That makes this medium neutral, while views: both for and against the riots were presented there. However, Polish people identify themselves culturally with Swedish establishment and 3.3. Limitation of coding Meaning of words used by people is very difficult to uniqueness classification. In our task we propose 10 main categories with 14 subcategories and attract presented words into given keywords related to descriptive category or subcategory. Classification is based on our subjective feeling. We tried to avoid words with many meanings. We had problems with words:  Stockholm/Sweden (does not only relate with that city/country, but also geographical location);  Swedish/Swedes (does not only describe citizenship of Sweden, but also the background of the riots);  all words classified to categories pro riots or pro police (words connoted with law or rebellion have mostly positive meaning, but not always);  all words classified to category external forces (e. g. none of media institution like radio, TV, press, or Internet companies names were included in investigation) Also all of categories have very wide range of potential connotation and some of them could overlap (e. g. where should be the border between employment and unemployment), but we tried to help ourselves with keyword list (Table 4). 3.4. Results of categorization From results, we can conclude, that the main conflict is going on around identity, police operation and riots itself, work and living issues. Politics, education and family related issues plays secondary role, but still such topics were discussed by Forum users. The main subject of discussion seems to focus around identity (the biggest count of related words) which was already observed from intensively of pronounce use (Table 3) . Moreover, motor of conflict could be defined as Swedes-They. While there are some coding problems with identity (are literary Swedes associated with literary category 7.2?), the second frequent category: Employment is probably the biggest single issue related to Stockholm’s riots mentioned by Forum users. The smallest subcategory (Police-pro) is one related to the positive side of police operation. One order of magnitude often Police was described by negative or neutral connotation. Fig. 5: Categories and categories containing subcategories. * means sum of all counts of subcategories for given category 3.5. Sentiment analysis of 2-grams with Police We extract all 2-grams where the word “police” or “police officer” appears. We run sentiment analysis on each 2-gram. The sentence sentiment strength1 could vary from -4 (very negative) to +4 (very positive). Most of them have been neutral and sensitive strength is 0. We analyze all those 2-grams, which were found more than once. To illustrate, we show few most frequent 2-grams (Table 5). Moreover, Polish stop words (without meaning) were excluded also. To get effective power, we multiply frequency by sensitive strength. The overall score of power for all 2 -grams containing word Police is slightly negative (-5). English 2 – gram No. sensi strenth Pow. 2- Polish gram szwedzka policja policja używa granatniki policjanci Swedish police 10 police uses police launchers 3 2 jaka policja what the police 2 mogła policja mordować policja police murders 2 police could 2 0 0 -1 0 0 -3 0 0 -2 0 0 -6 … … … … Sum Power -5 Table 5: Most frequent 2-grams with Police, Policeman or Police officer with their sentiment score and frequency. … 3.5. Conclusions and future works for Poloniainfo.se This work has only exploratory function, but even those preliminary results; we can propose few hypotheses, which should be checked by deeper investigation. The first one is related to Police operation. Please note, that we do not want to evaluate professionalism of Police, but only public opinion about their operation. Data- mining analysis proposed by us has many weak sides and it is usually very difficult to make clear conclusions from it. In the Police case, order of magnitude difference 1 We use tool: Sesnistrenth (Thelwall 2012) for English translation of Polish sentences Fig. 4: Categories and Subcategories from most to least popular between positive and both negative and neutral cases seem to be something more than methodological bias or artifact. Why Forum users even, they identify themself with Swedish establishment did not say almost anything positive about Police? Did PR department of Police work properly? One user wrote, that Swedish Police as a best paid organization in EU is one of the less effective at the same time. We propose to survey public evaluation about Police operation. Moreover sentiment and association analysis should also give some more insight, while preliminary results show little negative emotional orientation (Table 5). This sample is unfortunately too small for any conclusions and bigger datasets should be used to estimate actual sensitive power. Employment also seems to be relatively important topic (Fig. 4, 5). Work issue, with connotation with taxes and salaries should be more carefully investigated if that is really a leading factor of discussions about riots. It beats some aspects of identity (and even identity also if other coders would not include geographical word – e. g. Stockholm into identity category) and religion, living condition or education form frequentional analysis. However, it could come from bias, that Poles describing riots are mostly guest workers and work, as a single theme, is the most popular within Polish community in Sweden. 4. General findings, limitation of both studies and speculations The role of Police and politics should be investigated , because in Twitter politics (Table 2) and in Forum Police (Fig. 5) are the main motors of opinion spread between people. Both studies are only preliminary and just explore the field to set up questions to be ask by pragmatic research. Both datasets are not representative for the whole society and opinion shared in both mediums are very special to people who use them. Moreover in each study different methodology was used due to difference of data structure itself, and even in content. Some aspects revealed in one study were omitted in the second one. For example media institutions, which play important role in hash tag study, were not categorized anywhere in Forum case. However, similar issues come out from both mediums. As the result from this preliminary analysis hypotheses about emergence of media phenomena appear, while similar size riots reported by police went unnoticed (Nilsson 2012). For example: how influential actors used social media like bloggers, journalist, political activist made this topic so popular and it has been discussing till now (Fig. 1). The next part of this project will focus on network analysis of role of such actors. While sociologists try to understand mechanisms of riots arising, underlying psychological and sociological patterns, and the presentation of riots in the mass media, natural language processing and text mining are great supplementary tools for that. Criminologists, on the other hand, focus on recent causation theories and suggest various ways of controlling riots (Sarnecki 2001). They are aware of similar incidents and forecast intensification of riots in the future due to stratification of society with overrepresentation of "urban underclass”. That indicates the need for adjusting computational methods to problems, and this paper is a preliminary approach for that. Acknowledgments We would like to thank Hernan Mondani, Andrzej Grabowski, Fredrik Liljeros, Anita Zbieg, Lauren Dean, and Clara Lindblom, for discussions. AJ thanks to Svenska Institutet for invitation to Sweden. References Barker, V. (2013). Policing Membership in Husby: Four Factors to the Stockholm Riots. Border Criminologies Blog Post: 3 June. Babtist, J.M. (2010.) Quantitative Analysis of Culture Using Millions of Digitized Books. Science 331 (6014). Bauman, Z. (1996). From pilgrim to tourist–or a short history of identity. Questions of cultural identity. pp 19-38. London. Buda, A. and Jarynowski, A. (2013). Network Structure of Phonographic Market with Characteristic In: Acta Physica Similarities between Artists, Polonica A , vol. 123 (2). Chmiel, A., Sienkiewicz, J., Thelwall, M., Paltoglou, G., Buckley, K., Kappas, A., & Hołyst, J. A. (2011). Collective emotions online and their influence on community life. PloS one, 6(7), e22207. Gustafsson, S.M., Sikström, S. & Lindholm, T. (in press). Selection Bias in Choice of Words: Evaluations of ”I” and ”We” Differ between Contexts, but ”They” are Always Worse. Journal of Social Psychology and Language. Hallsworth, S. and Brotherton, D. (2012). Urban Disorder and Gangs: A Critique and a Warning. London: Runnymede Trust. Jarynowski, A., Zbieg, A. and Jankowski, J. (2013) Viral spread with or without emotions in online community. arXiv preprint arXiv:1302.3086. Mouge, P. & Contractor, N. (2003). Theories of Communication Networks. Cambridge: Oxford University Press. Nilsson, T., and Westerberg, A. I. (2012). Våldsamma upplopp i Sverige–från avvikelse till normalitet. MSB:Stockholm. Theguardian & LSE. (2011). Reading the Riots. London. Thelwall, M. (2012) Sentiment strength detection for the social Web. Journal of the American Society for Information Science and Technology, vol. 63 (1). Yuskiv, B. (2006). Content analysis. History development and world practice. Rowne. Rostami, A. (2013). Linnéuniversitetet:Linkopping. Sarnecki, J. (2001). Delinquent networks. Cambridge: Cambridge University Press. Sobkowicz, P. and Sobkowicz, A. (2012). Two-year study of emotion and communication patterns in a highly polarized political discussion forum. Social Science Computer Review, 30(4), 448-469. Zbieg, A., Żak, B., Jankowski, J., Michalski, R. and Ciuberek, S. (2012). Studying Diffusion of Viral Content at Dyadic Level. In: ASONAM 2012, Istambul. Fiender, Tusen
1603.01895
2
1603
2016-05-30T14:14:16
Bounds on the Voter Model in Dynamic Networks
[ "cs.SI", "cs.DS" ]
In the voter model, each node of a graph has an opinion, and in every round each node chooses independently a random neighbour and adopts its opinion. We are interested in the consensus time, which is the first point in time where all nodes have the same opinion. We consider dynamic graphs in which the edges are rewired in every round (by an adversary) giving rise to the graph sequence $G_1, G_2, \dots $, where we assume that $G_i$ has conductance at least $\phi_i$. We assume that the degrees of nodes don't change over time as one can show that the consensus time can become super-exponential otherwise. In the case of a sequence of $d$-regular graphs, we obtain asymptotically tight results. Even for some static graphs, such as the cycle, our results improve the state of the art. Here we show that the expected number of rounds until all nodes have the same opinion is bounded by $O(m/(d_{min} \cdot \phi))$, for any graph with $m$ edges, conductance $\phi$, and degrees at least $d_{min}$. In addition, we consider a biased dynamic voter model, where each opinion $i$ is associated with a probability $P_i$, and when a node chooses a neighbour with that opinion, it adopts opinion $i$ with probability $P_i$ (otherwise the node keeps its current opinion). We show for any regular dynamic graph, that if there is an $\epsilon>0$ difference between the highest and second highest opinion probabilities, and at least $\Omega(\log n)$ nodes have initially the opinion with the highest probability, then all nodes adopt w.h.p. that opinion. We obtain a bound on the convergences time, which becomes $O(\log n/\phi)$ for static graphs.
cs.SI
cs
Bounds on the Voter Model in Dynamic Networks Petra Berenbrink∗1, George Giakkoupis†2, Anne-Marie Kermarrec‡2, and Frederik Mallmann-Trenn§1,3 1Simon Fraser University, Burnaby, Canada 2INRIA, Rennes, France 3École Normale Supérieure, Paris, France October 22, 2018 Abstract In the voter model, each node of a graph has an opinion, and in every round each node chooses independently a random neighbour and adopts its opinion. We are interested in the consensus time, which is the first point in time where all nodes have the same opinion. We consider dynamic graphs in which the edges are rewired in every round (by an adversary) giving rise to the graph sequence G1, G2, . . . , where we assume that Gi has conductance at least φi. We assume that the degrees of nodes don't change over time as one can show that the consensus time can become super-exponential otherwise. In the case of a sequence of d-regular graphs, we obtain asymptotically tight results. Even for some static graphs, such as the cycle, our results improve the state of the art. Here we show that the expected number of rounds until all nodes have the same opinion is bounded by O(m/(dmin · φ)), for any graph with m edges, conductance φ, and degrees at least dmin. In addition, we consider a biased dynamic voter model, where each opinion i is associated with a probability Pi, and when a node chooses a neighbour with that opinion, it adopts opinion i with probability Pi (otherwise the node keeps its current opinion). We show for any regular dynamic graph, that if there is an ǫ > 0 difference between the highest and second highest opinion probabilities, and at least Ω(log n) nodes have initially the opinion with the highest probability, then all nodes adopt w.h.p. that opinion. We obtain a bound on the convergence time, which becomes O(log n/φ) for static graphs. 1 Introduction In this paper, we investigate the spread of opinions in a connected and undirected graph using the voter model. The standard voter model works in synchronous rounds and is defined as follows. At the beginning, every node has one opinion from the set {0, . . . , n− 1}, and in every round, each node chooses one of its neighbours uniformly at random and adopts its opinion. In this model, one is usually interested in the consensus time and the fixation probability. The consensus time is the number of rounds it takes until all nodes have the same opinion. The fixation probability of opinion i is the probability that this opinion prevails, meaning that all other opinions vanish. This probability is known to be proportional to the sum of the degrees of the nodes starting with opinion i [15, 26]. The voter model is the dual of the coalescing random walk model which can be described as follows. Initially, there is a pebble on every node of the graph. In every round, every pebble chooses a neighbour uniformly at random and moves to that node. Whenever two or more pebbles meet at the same node, they are merged into a single pebble which continues performing a random walk. The process terminates when only one pebble remains. The time it takes until only one pebble remains is called coalescing time. It is known that the coalescing time for a graph G equals the consensus time of the voter model on G when initially each node has a distinct opinion [2, 21]. In this paper we consider the voter model and a biased variant where the opinions have different popularity. We express the consensus time as a function of the graph conductance φ. ∗[email protected][email protected][email protected] §[email protected] 1 We assume a dynamic graph model where the edges of the graph can be rewired by an adversary in every round, as long as the adversary respects the given degree sequence and the given conductance for all generated graphs. We show that consensus is reached with constant probability after τ rounds, where τ is the first round such that the sum of conductances up to round τ is at least m/dmin, where m is the number of edges. For static graphs the above bound simplifies to O(m/(dmin · φ)), where dmin is the minimum degree. For the biased model we assume a regular dynamic graph G. Similar to [18, 21] the opinions have a popularity, which is expressed as a probability with which nodes adopt opinions. Again, every node chooses one of its neighbours uniformly at random, but this time it adopts the neighbour's opinion with a probability that equals the popularity of this opinion (otherwise the node keeps its current opinion). We assume that the popularity of the most popular opinion is 1, and every other opinion has a popularity of at most 1 − ǫ (for an arbitrarily small but constant ǫ > 0). We also assume that at least Ω(log n) nodes start with the most popular opinion. Then we show that the most popular opinion prevails w.h.p.1 after τ rounds, where τ is the first round such that the sum of conductances up to round τ is of order O(log n). For static graphs the above bound simplifies as follows: the most popular opinion prevails w.h.p. in O(log n/φ) rounds, if at least Ω(log n) nodes start with that opinion. 1.1 Related work A sequential version of the voter model was introduced in [16] and can be described as follows. In every round, a single node is chosen uniformly at random and this node changes its opinion to that of a random neighbour. The authors of [16] study infinite grid graphs. This was generalised to arbitrary graphs in [11] where it is shown among other things that the probability for opinion i to prevail is proportional to the sum of the degrees of the nodes having opinion i at the beginning of the process. The standard voter model was first analysed in [15]. The authors of [15] bound the expected coalescing time (and thus the expected consensus time) in terms of the expected meeting time tmeet of two random walks and show a bound of O(tmeet · log n) = O(n3 log n). Note that the meeting time is an obvious lower bound on the coalescing time, and thus a lower bound on the consensus time when all nodes have (log4 n + ρ)(cid:1) distinct opinions initially. The authors of [6] provide an improved upper bound of O(cid:0) 1 matrix of a random walk on G, and ρ = (cid:0)Pu∈V (G) d(u)(cid:1)2 /Pu∈V (G) d2(u) is the ratio of the square of the sum of node degrees over the sum of the squared degrees. The value of ρ ranges from Θ(1), for the star graph, to Θ(n), for regular graphs. on the expected coalescing time for any graph G, where λ2 is the second eigenvalue of the transition 1−λ2 The authors of [2, 21, 22] investigate coalescing random walks in a continuous setting where the movement of the pebbles are modelled by independent Poisson processes with a rate of 1. In [2], it is shown a lower bound of Ω(m/dmax) and an upper bound of O(thit · log n) for the expected coalescing time. Here m is the number of edges in the graph, dmax is the maximum degree, and thit is the (expected) hitting time. In [27], it is shown that the expected coalescing time is bounded by O(thit). In [21] the authors consider the biased voter model in the continuous setting and two opinions. They show that for d-dimensional lattices the probability for the less popular opinion to prevail is exponentially small. In [18], it is shown that in this setting the expected consensus time is exponential for the line. The authors of [7] consider a modification of the standard voter model with two opinions, which they call two-sample voting. In every round, each node chooses two of its neighbours randomly and adopts their opinion only if they both agree. For regular graphs and random regular graphs, it is shown that two-sample voting has a consensus time of O(log n) if the initial imbalance between the nodes having the two opinions is large enough. There are several other works on the setting where every node contacts in every round two or more neighbours before adapting its opinion [1, 8, 9, 12]. There are several other models which are related to the voter model, most notably the Moran process and rumor spreading in the phone call model. In the case of the Moran process, a population resides on the vertices of a graph. The initial population consists of one mutant with fitness r and the rest of the nodes are non-mutants with fitness 1. In every round, a node is chosen at random with probability proportional to its fitness. This node then reproduces by placing a copy of itself on a randomly chosen neighbour, replacing the individual that was there. The main quantities of interest are the probability that the mutant occupies the whole graph (fixation) or vanishes (extinction), together with the time before either of the two states is reached (absorption time). There are several publications considering the fixation probabilities [10, 17, 23]. 1An event happens with high probability (w.h.p.) if its probability is at least 1 − 1/n. 2 Rumor spreading in the phone call model works as follows. Every node v opens a channel to a ran- domly chosen neighbour u. The channel can be used for transmissions in both directions. A transmission from v to u is called push transmission and a transmission from u to v is called pull. There is a vast amount of papers analysing rumor spreading on different graphs. The result that is most relevant to ours is that broadcasting of a message in the whole network is completed in O(log n/φ) rounds w.h.p, where φ is the conductance (see Section 1.2 for a definition) of the network. In [14], the authors study rumor spreading in dynamic networks, where the edges in every round are distributed by an adaptive adversary. They show that broadcasting terminates w.h.p. in a round t if the sum of conductances up to round t is of order log n. Here, the sequence of graphs G1, G2, . . . have the same vertex set of size n, but possibly distinct edge sets. The authors assume that the degrees and the conductance may change over time. We refer the reader to the next section for a discussion of the differences. Dynamic graphs have received ample attention in various areas [4, 19, 20, 28]. 1.2 Model and New Results In this paper we show results for the standard voter model and biased voter model in dynamic graphs. Our protocols work in synchronous steps. The consensus time T is defined at the first time step at which all nodes have the same opinion. Standard Voter Model. Our first result concerns the standard voter model in dynamic graphs. Our protocol works as follows. In every synchronous time step every node chooses a neighbour u.a.r. and adopts its opinion with probability 1/2.2 We assume that the dynamic graphs G = G1, G2, . . . are generated by an adversary. We assume that each graph has n nodes and the nodes are numbered from 1 to n. The sequence of conductances φ1, φ2, . . . is given in advance, as well as a degree sequence d1, d2, . . . , dn. The adversary is now allowed to create every graph Gi by redistributing the edges of the graph. The constraints are that each graph Gi has to have conductance φi and node j has to have degree dj (the degrees of the nodes do not change over time). Note that the sequence of the conductances is fixed and, hence, cannot be regarded as a random variable in the following. For the redistribution of the edges we assume that the adversary knows the distribution of all opinions during all previous rounds. Note that our model for dynamic graphs is motivated by the model presented in [14]. They allow the adversary to determine the edge set at every round, without having to respect the node degrees and conductances. We show (Observation 1) that, allowing the adversary to change the node degrees over time can results in super-exponential voting time. Since this changes the behaviour significantly, we assume that the degrees of nodes are fixed. Furthermore, in contrary to [14], we assume that (bounds on) the conductance of (the graph at any time step) are fixed/given beforehand. Whether one can obtain the same results, if the conductance of the graph is determined by an adaptive adversary remains an open question. The reason we consider an adversarial dynamic graph model is in order to understand how the voting time can be influenced in the worst-case. Another interesting model would be to assume that in every round the nodes are connected to random neighbours. One obstacle to such a model seems to be to guarantee that neighbours are chosen u.a.r. and the degrees of nodes do not change. For the case of regular random dynamic graphs our techniques easily carry over since the graph will have constant conductance w.h.p. in any such round since the graph is essentially a random regular graph in every round. For the (adversarial) dynamic model we show the following result bounding the consensus time T . Theorem 1.1 (upper bound). Consider the Standard Voter model and in the dynamic graph model. Assume κ ≤ n opinions are arbitrarily distributed over the nodes of G1. Let φt be a lower bound on the conductance at time step t. Let b > 0 be a suitable chosen constant. Then, with a probability of 1/2 we have that T ≤ min{τ, τ ′}, where (i) τ is the first round so that Pτ (ii) τ ′ is the first round so that Pτ ′ For static graphs (Gi+1 = Gi for all i), we have T ≤ min{m/(dmin · φ), n log n/φ2}. t=1 φt ≥ b · m/dmin. (part 1) t=1 φ2 (part 2) t ≥ b · n log n. For static d-regular graphs, where the graph doesn't change over time, the above bound becomes O(n/φ), which is tight when either φ or d are constants (see Observation 2). Theorem 1.1 gives the first 2The factor of 1/2 ensures that the process converges on bipartite graphs. 3 tight bounds for cycles and circulant graphs Ck n (node i is adjacent to the nodes i ± 1, . . . , i ± k mod n) with degree 2k (k constant). For these graphs the consensus time is Θ(n2), which matches our upper bound from Theorem 1.1.3 For a comparison with the results of [6] note that φ2 ≤ 1 − λ2 ≤ 2φ. In particular, for the cycle φ = 1/n and 1/(1 − λ2) = Θ(1/n2). Hence, for this graph, our bound is by a factor of n smaller. Note that, due to the duality between the voter model and coalescing random walks, the result also holds for the coalescing time. In contrast to [6,7], the above result is shown using a potential function argument, whereas the authors of [6,7] show their results for coalescing random walks and fixed graphs. The advantage of analysing the process directly is, that our techniques allow us to obtain the results for the dynamic setting. The next result shows that the bound of Theorem 1.1 is asymptotically tight if the adversary is allowed to change the node degrees over time. Theorem 1.2 (lower bound). Consider the Standard Voter model in the dynamic graph model. Assume that κ ≤ n opinions are arbitrarily distributed over the nodes of G1. Let φt be an upper bound on the conductance at time step t. Let b > 0 be a suitable constant and assume τ ′′ is the first round such that Pτ ′′ t=1 φt ≥ bn. Then, with a probability of at least 1/2, there are still nodes with different opinions in Gτ ′′ . Biased Voter Model In the biased voter model we again assume that there are κ ≤ n distinct opinions initially. For 0 ≤ i ≤ κ − 1, opinion i has popularity αi and we assume that α0 = 1 > α1 ≥ α2 ≥ . . . ≥ ακ−1. We call opinion 0 the preferred opinion. The process works as follows. In every round, every node chooses a neighbour uniformly at random and adopts its opinion i with probability αi. We assume that the dynamic d-regular graphs G = G1, G2, . . . are generated by an adversary. We assume that the sequence of φt is given in advance, where φi is a lower bound on the conductance of Gi. The adversary is now allowed to create the sequence of graphs by redistributing the edges of the graph in every step. The constraints are that each graph Gi has n nodes and has to have conductance at least φi. Note that we assume that the sequence of the conductances is fixed and, hence, it is not a random variable in the following. The following result shows that consensus is reached considerably faster in the biased voter model, as long as the bias 1 − α1 is bounded away from 0, and at least a logarithmic number of nodes have the preferred opinion initially. Theorem 1.3. Consider the Biased Voter model in the dynamic regular graph model. Assume κ ≤ n opinions are arbitrarily distributed over the nodes of G1. Let φt be a lower bound on the conductance at time step t. Assume that α1 ≤ 1 − ǫ, for an arbitrary small constant ǫ > 0. Assume the initial number of nodes with the preferred opinion is at least c log n, for some constant c = c(α1). Then the preferred opinion prevails w.h.p. in at most τ ′′′ steps, where τ ′′′ is the first round so that Pτ ′′′ t=1 φt ≥ b log n, for some constant b. For static graphs (Gi+1 = Gi for all i), we have w.h.p. T = O(log n/φ). The assumption on the initial size of the preferred opinion is crucial for the time bound T = O(log n/φ), in the sense that there are instances where the expected consensus time is at least T = Ω(n/φ) if the size of the preferred opinion is small.4 The rumor spreading process can be viewed as an instance of the biased voter model with two opinions having popularity 1 and 0, respectively. However, the techniques used for the analysis of rumor spreading do not extend to the voter model. This is due to the fact that rumor spreading is a progressive process, where nodes can change their opinion only once, from "uninformed" to "informed", whereas they can change their opinions over and over again in the case of the voter model. Note that the above bound is the same as the bound for rumor spreading of [13] (although the latter bound holds for general graphs, rather than just for regular ones). Hence, our above bound is tight for regular graphs with conductance φ, since the rumor spreading lower bound of Ω(log n/φ) is also a lower bound for biased voting in our model. 3The lower bound of Ω(n2) follows from the fact that two coalescing random walks starting on opposite sites of a cycle require in expectation time Ω(n2) to meet. 4Consider a 3-regular graph and n opinions where all other α1 = α2 = · · · = αn−1 = 1/2. The preferred opinion vanishes with constant probability and the bound for the standard voter model of Observation 2 applies. 4 2 Analysis of the Voter Model In this section we show the upper and lower bound for the standard voter model. We begin with some definitions. Let G = (V, E). For a fixed set S ⊆ V we define cut(S, V \ S) to be the set of edges between the sets S ⊆ V and V \ S and let λu be the number of neighbours of u in V \ S. Let vol(S) =Pu∈S du. The conductance of G is defined as φ = φ(G) = minn Pu∈U λu vol(U) : U ⊂ V with 0 < vol(U ) ≤ mo . We note 1/n2 ≤ φ ≤ 1. We denote by v(i) and t ≥ 0. If we refer to the random variable we use V (i) t t instead. the set of nodes that have opinion i after the first t rounds First we show Theorem 1.1 for κ = 2 (two opinions), which we call 0 and 1 in the following. Then we generalise the result to an arbitrary number of opinions. We model the system with a Markov chain Mt≥0 = (V (0) , V (1) )t≥0. t t Let st denote the set having the smaller volume, i.e., st = v(0) otherwise. Note that we use st, v(0) for the corresponding random variables. For u ∈ v(0) and for u ∈ v(1) , λu,t is the number of neighbours of u in V \ v(0) and v(1) if vol(v(0) t whenever the state at time t is fixed, and St, V (0) ) ≤ vol(v(1) ), and st = v(1) and V (1) , λu,t is the number of neighbours of u in V \ v1(t) ; du is the degree of u (the degrees do t t t t t t t t t not change over time). t To analyse the process we use a potential function. Simply using the volume of nodes sharing the same opinion as the potential function will not work. It is easy to calculate that the expected volume of nodes with a given opinion does not change in one step. Instead, we use a convex function on the number of nodes with the minority opinion. We define In Lemma 2.1 we first calculate the one-step potential drop of Ψ(St). Then we show that every opinion either prevails or vanishes once the sum of conductances is proportional to the volume of nodes having that opinion (see Lemma 2.2), which we use later to prove Part 1 and 2 of Theorem 1.1. Ψ(St) =pvol(St). Lemma 2.1. Assume st 6= ∅ and κ = 2. Then E[Ψ(St+1) St = st] ≤ Ψ(st) − Pu∈V λu,t · du 32 · (Ψ(st))3 . Proof. W.l.o.g. we assume that opinion 0 is the minority opinion, i.e. 0 < vol(V (0) simplify the notation we omit the index t in this proof and write v(0) instead of vt(0), v(1) for V \ v(0) and λu instead of λu,t. Hence, st = v(0) and Ψ(st) = pvol(v(0)). Note that for t = 0 we have vol(v(0)) = Ψ(st)2. Furthermore, we fix St = st in the following (and condition on it). We define m as the number of edges. Then we have ) ≤ vol(V (1) ). To , t t t E[Ψ(St+1) − Ψ(st) St = st] = E[pvol(St+1) −pvol(st)] and ∆ =Pu∈V Xu. Note that we have ∆ = vol(V (0) t+1) − vol(v(0)) and E(cid:20)qvol(V (0) t+1) −qvol(v(0))(cid:21) = E(cid:20)qvol(v(0)) + ∆ −qvol(v(0))(cid:21) 5 Now we define t+1), m − vol(V (0) t+1)o −pvol(st)# (1) = E"rminnvol(V (0) ≤ E(cid:20)qvol(V (0) t+1) −qvol(v(0))(cid:21) if u ∈ v(1) if u ∈ v(0) 2·du w.p. λu du 2·du −du w.p. λu otherwise 0 Xu =  ∆ = E(cid:20)qvol(v(0))(cid:16)q1 + = Ψ(st) · E[p1 + ∆/Ψ(st)2 − 1]. vol(v(0)) − 1(cid:17)(cid:21) Unfortunately we cannot bound Ψ(st) · E[p1 + ∆/Ψ(st)2 − 1] directly. Instead, we define a family of random variables which is closely related to Xu. w.p. 1 λu 2 −du w.p. λu otherwise 0 2·du if u ∈ v(1) if u ∈ v(0) Yu =  Lemma A.1, we show that Similarly, we define ∆′ = Pu∈V Y (u). Note that E[Yu] = λu/2 for both u ∈ v(1) and u ∈ v(0). In which results in E[Ψ(St+1)− Ψ(st) St = st] ≤ Ψ(st)· E[p1 + ∆′/Ψ(st)2− 1] From the Taylor expansion √1 + x ≤ 1 + x E[p1 + ∆/Ψ(st)2] ≤ E[p1 + ∆′/Ψ(st)2]. 2Ψ(st)2 − (∆′)2 8Ψ(st)4 + (∆′)3 16Ψ(st)6(cid:3). It remains to bound E[∆′], E[(∆′)2], and E[(∆′)3]. 8 + x3 16 , x ≥ −1 it follows that 2 − x2 E[Ψ(St+1) − Ψ(st) St = st] ≤ Ψ(st) · E(cid:2) ∆′ 2 −Pv∈v(0) • E[∆′]: We have E[∆′] =Pu∈V E[Yu] =Pu∈v(1) sincePu∈v(1) λu andPu∈v(1) λu both count the number of edges crossing the cut between v(0) and • E[(∆′)2]: since E[(Yu)2] = (λu)2/2 for u ∈ v(1) and E[(Yu)2] = −du · λu/2 for u ∈ v(0) we have λv 2 = 0, where the last equality holds v(1). λu Var[Yu] + 0 = Xu∈V (E[(Yu)2] − (E[Yu])2) E[(∆′)2] = Xu∈V = Xu∈v(0) = Xu∈v(0) Var[Yu] + (E[Yu])2 = Xu∈V (E[(Yu)2] − (E[Yu])2) + Xu∈v(1) 2 − Xu∈v(0) + Xu∈v(1) λ2 u 4 λudu λ2 u (E[(Yu)2] − (E[Yu])2) 4 ≥ Xu∈v(0) λudu 4 . • E[∆′3]: In Lemma A.2 we show that Note that E[(Yu)3] = 1 2 λu · (du)2 for u ∈ v(0). Hence, E[∆′3] = Xu∈V (cid:0) E[(Yu)3] − 3 E[(Yu)2] · E[Yu] + 2 E[Yu]3(cid:1). 2 (λu)3 for u ∈ v(1) and E[(Yu)3] = − 1 E[∆′3] = Xu∈v(0)(cid:18)− + Xu∈v(1)(cid:18) 1 u(cid:19) (λu)3(cid:19) ≤ 0, λu · (du)2 + 3 4 (λu)2 · du − (λu)3 − (λu)3 + 1 4 1 4 1 2 3 4 λ3 2 Combining all the above estimations we get where the first sum is bounded by 0 because λu ≤ du. E[Ψ(St+1) − Ψ(st) St = st] ≤ Ψ(st) · E(cid:20) ∆′ 2Ψ(st)2 − ∆′2 8Ψ(st)4 + ∆′3 16Ψ(st)6(cid:21) ≤ −Pu∈v(0) λudu 32Ψ(st)3 (2) (3) . This completes the proof of Lemma 2.1. 2.1 Part 1 of Theorem 1.1. Using Lemma 2.1 we show that a given opinion either prevails or vanishes with constant probability as soon as the sum of φt is proportional to the volume of the nodes having that opinion. 6 Lemma 2.2. Assume that st is fixed for an arbitrary (t ≥ 0) and κ = 2. i=t φi ≥ 129 · vol(st)/dmino. Then Pr(cid:0)T ≤ τ ∗ + t(cid:1) ≥ 1/2. Let τ ∗ = minnt′ :Pt′ In particular, if the graph is static with conductance φ, then Pr(cid:0)T ≤ 129·vol(st) Proof. From the definition of Ψ(st) and φt it follows for all t that Ψ(st)2 = Pu∈v(0) du = vol(v(0)) and φt ≤ Pu∈v(0) λu,t/vol(v(0)). Hence, Ψ(st)2 · φt · dmin ≤ Pu∈v(0) λu,t · du. Together with Lemma 2.1 we derive for st 6= ∅ + t(cid:1) ≥ 1/2. φ·dmin E[Ψ(St+1) St = st] ≤ Ψ(st) − Pu∈V λu,t · du 32 · (Ψ(st))3 ≤ Ψ(st) − dmin · φt 32 · Ψ(st) . (4) Recall that T = mint{St = ∅}. In the following we use the expression T > t to denote the event st 6= ∅. Using the law of total probability we get and using Jensen's inequality we get dmin · φt T > t(cid:21) E[Ψ(St+1)T > t] = E(cid:20)Ψ(St) − 32 · Ψ(St)(cid:12)(cid:12)(cid:12) E[Ψ(St+1) T > t] = E[Ψ(St) T > t] − E(cid:20) dmin · φt 32 · Ψ(St) T > t(cid:21) dmin · φt 32 · E[Ψ(St)· T > t] ≤ E[Ψ(St) T > t] − . Since E[Ψ(St) T ≤ t] = 0 we have E[Ψ(St)] = E[Ψ(St) T > t] · Pr[T > t] + E[Ψ(St) T ≤ t] · Pr[T ≤ t] = E[Ψ(St) T > t] · Pr[T > t] + 0. Hence, and E[Ψ(St+1)] Pr (T > t) ≤ E[Ψ(St)] Pr (T > t) − dmin · φt · Pr (T > t) 32 E[Ψ(St)] E[Ψ(St+1)] ≤ E[Ψ(St)] − dmin · φt · (Pr (T > t))2 32 E[Ψ(St)] . Let t∗ = min{t : Pr(T > t) < 1/2}. In the following we use contradiction to show t∗ ≤ max{t : Xt≤t<t∗ φt ≤ 128 · vol(st)/dmin}. Assume the inequality is not satisfied. With t = t∗ − 1 we get dmin · φt · (Pr(T > t∗ − 1))2 E[Ψ(St∗ )] ≤ E[Ψ(St∗−1)] − 32 E[Ψ(St∗−1)] ≤ E[Ψ(St∗−1)] − dmin · φt∗ · (1/4) 32 E[Ψ(St∗−1)] . Applying this equation iteratively, we obtain E[Ψ(St∗)] ≤ E[Ψ(St)] − Xt≤t<t∗ dmin · φt · 1/4 32 E[Ψ(St)] ≤ E[Ψ(St)] − dmin ·Pt≤t<t∗ φt 128 E[Ψ(St)] . (5) Using the definition of E[Ψ(St)] =pvol(st) and the definition of t∗ we get =qvol(st) − E[Ψ(St∗)] <qvol(st) − dmin · 128 · vol(st) 128 · dmin ·pvol(st) This is a contradiction since E[Ψ(St∗ )] is non-negative. = 0. vol(st) pvol(st) From the definition of t∗, we obtain Pr(cid:0)T > τ ∗ + t(cid:1) < 1/2, completing the proof of Lemma 2.2. Now we are ready to show the first part of the theorem. 7 ℓ0 = κ. Proof of Part 1 of Theorem 1.1. We divide the τ rounds into phases. Phase i starts at time τi = min{t : Pt j=1 φj ≥ 2i} for i ≥ 0 and ends at τi+1 − 1. Since φj ≤ 1 for all j ≥ 0 we have τ0 < τ1 < . . . and Pτi+1 j=τi φj ≥ 1 for i ≥ 0. Let ℓt be the number of distinct opinions at the beginning of phase t. Hence, We show in Lemma 2.3 below that the expected number of phases before the number of opinions drops by a factor of 5/6 is bounded by 6c · vol(V )/(ℓt · dmin). For i ≥ 1 let Ti be the number of phases needed so that the number of opinions drops to (5/6)i · ℓ0. Then only one opinion remains after log6/5 κ many of these meta-phases. Then, for a suitably chosen constant b, E[T ] = log6/5 κ log6/5 κ−1 E[Tj] ≤ Xj=1 Xj=1 6c · vol(V ) ℓj · dmin ≤ log6/5 κ Xj=1 6c vol(V ) (5/6)j · ℓ0 · dmin = b · m 4 · dmin . By Markov inequality, consensus is reached w.p. at least 1/2 after b · m/(2dmin) phases. By definition of τ and the definition of the phases, we have that the number of phases up to time step τ is at least b·m/(2dmin). Thus, consensus is reached w.p. at least 1/2 after τ time steps, which finishes the proof. Lemma 2.3. Fix a phase t and assume c = 129 and ℓt > 1. The expected number of phases before the number of opinions drops to 5/6 · ℓt is bounded by 6c · vol(V )/(ℓt · dmin). Proof. Consider a point when there are ℓ′ opinions left, with 5/6 · ℓ < ℓ′ ≤ ℓ. Among those ℓ′ opinions, there are at least ℓ′ − ℓ/3 opinions i such that the volume of nodes with opinion i is at most 3 · vol(V )/ℓ. Let S denote the set of these opinions and let Zi be an indicator variable which is 1 if opinion i ∈ S vanished after s = 3c · vol(V )/(ℓ · dmin) phases and Zi = 0 if it prevails. To estimate Zi we consider the process where we have two opinions only. All nodes with opinion i retain their opinion and all other nodes have opinion 0. It is easy to see that in both processes the set of nodes with opinion i remains exactly the same. Hence, we can use Lemma 2.2 to show that with probability at least 1/2, after s phases opinion i either vanishes or prevails. Hence, E [Σj∈SZj] = Σj∈S E[Zj] ≥ S/2 ≥ (ℓ′ − ℓ/3)/2. Using Markov's inequality we get that with probability 1/2 at least (ℓ′−ℓ/3)/4 opinions vanish within s phases, and the number of opinions remaining is at most ℓ′− (ℓ′− ℓ/3)/4 = 3/4· ℓ′ + ℓ/12 ≤ 5/6· ℓ. The expected number of phases until 5/6 · ℓ opinions can be bounded by P∞ i=1 2−i · s ≤ 2s = 6c·vol(V ) ℓ·dmin . 2.2 Part 2 of Theorem 1.1 The following lemma is similar to Lemma 2.2 in the last section: We first bound the expected potential drop in round t + 1, i.e., we bound E[Ψ(St+1) − Ψ(st) St = st]. This time however, we express the drop as a function which is linear in Ψ(st). This allows us to bound the expected size of the potential at time τ ′, i.e., E[Ψ(Sτ ′)], directly. From the expected size of the potential at time τ ′ we derive the desired bound on P r (T ≤ τ ′). Lemma 2.4. Assume κ = 2. We have Pr (T ≤ τ ′) ≥ 1/n2. In particular, if the graph is static with conductance φ, then Pr(cid:0)T ≤ 96·n log n Proof. In the following we fix a point in time t and use λu instead of λu,t. From Lemma 2.1 and the observation λu ≤ du we obtain for st 6= ∅ (cid:1) ≥ 1 − 1/n2. φ2 E[Ψ(St+1) − Ψ(st) St = st] ≤ −Pu∈V λu · du 32 · (Ψ(st))3 ≤ −Pv∈v(0) (λu)2 32(Ψ(st))3 . =(cid:0)Pv∈v(0) λu · 1(cid:1)2 We have, by Cauchy-Schwarz inequality, (cid:0)Pv∈v(0) λu(cid:1)2 ≤Pv∈v(0) (λu)2 · n. Hence, (λu)2 ≥ (cid:0)Pv∈v(0) λu(cid:1)2 Ψ(st)4 · (φt)2 (vol(v0))2 · (φt)2 ≥ ≥ n n n Xv∈V (λu)2 ≥ Xv∈v(0) , where the third inequality follows by definition of φt. Hence, for st 6= ∅ we have E[Ψ(St+1) − Ψ(st) St = st] ≤ − Ψ(st) · (φt)2 32n . 8 Note that E[Ψ(St+1) St = ∅] = 0 = (1 − (φt)2 E[Ψ(St+1)] = E[E[Ψ(St+1) St = st]] ≤(cid:18)1 − 32n ) · E[Ψ(∅)]. Hence, for all t ≥ 1 we get 32n (cid:19) · E[Ψ(st)]. (φt)2 Applying this recursively yields E[Ψ(St+1)] ≤ Ψ(S0) · (φi)2 32n (1 − t Yi=0 ) ≤ Ψ(S0) · 1 − 1 t + 1Xi≤t (φi)2 32n   t+1 ≤ Ψ(S0) · exp Xi≤t (φi)2 32n   , where the second inequality follows from the Inequality of arithmetic and geometric means. By definition of τ ′, and from the observation Ψ(S0) ≤ n we get that E[Ψ(Sτ ′)] ≤ n−2. We derive n−2 ≥ E[Ψ(Sτ ′)] ≥ 0 · Pr(Ψ(Sτ ′) = 0) + 1 · (1 − Pr(Ψ(Sτ ′) = 0)), (6) where we used that min{Ψ(S) : S ⊆ V : S 6= ∅} ≥ 1. Solving (6) for Pr(Ψ(Sτ ′) = 0 gives Pr(Ψ(Sτ ′) = 0) ≥ 1 − 1/n2. Since κ = 2, it follows that Pr(T ≤ τ ′) = Pr(Ψ(Sτ ′) = 0) ≥ 1 − 1/n2, which yields the claim. We now prove Part 2 of Theorem 1.1 which generalises to κ > 2. Proof of Part 2 of Theorem 1.1. We define a parameterized version of the consensus time T . We define T (κ) = min{t : Ψ(St) = 0 : the number of different opinions at time t is κ} for κ ≤ n. We want to show that Pr(T (κ) ≤ τ ′) ≥ 1 − 1/n. From Lemma 2.4 we have that, that Pr(T (2) ≤ τ ′) ≥ 1 − 1/n2. We define the 0/1 random variable Zi to be one if opinion i vanishes or is the only remaining opinion after τ ′ rounds and Zi = 0 otherwise. We have that Pr(Zi = 1) ≥ 1 − 1/n2 for all i ≤ κ. We derive Pr(T (κ) ≤ τ ′) = Pr(∧i≤κZi) ≥ 1 − 1/n, by union bound. This yields the claim. 2.3 Lower Bounds In this section, we give the intuition behind the proof of Theorem 1.2 and state two additional obser- vations. Recall that Theorem 1.2 shows that our bound for regular graphs is tight for the adaptive adversary, even for k = 2. The first observation shows that the expected consensus time can be super- exponential if the adversary is allowed to change the degree sequence. The second observation can be regarded as a (weaker) counter part of Theorem 1.2 showing a lower bound of Ω(n/φ) for static graphs, assuming that either d or φ is constant. We now give the intuition behind the proof of Theorem 1.2. The high level approach is as follows. For every step t we define an adaptive adversary that chooses Gt+1 after observing V (0) . The adversary chooses Gt+1 such that the cut between V (0) is of order of Θ(φt · dn). We show that such a graph exists when the number of nodes in both V (0) is at least of linear size (in n). By this choice the adversary ensures that the expected potential drop of Ψ(St+1) at most −cφtd/Ψ(st) for some constant c. Then we use the expected potential drop, together with the optional stopping theorem, to derive our lower bound. t and V (1) and V (1) and V (1) t t t t t We proceed by giving a lower bound on the potential drop assuming a cut-size of Θ(φt · d · n). Lemma 2.5. Assume cut(st, V \ st) ≤ cφt · dn for some constant c. Then we have E[Ψ(St+1) St = st] ≥ Ψ(st) − c · φt · d Ψ(st) . (7) Proof. The proof is similar to the proof of Lemma 2.1. E [Ψ(St+1) − Ψ(st) St = st] = = E[pvol(St+1) −pvol(st)] = E"rminnvol(V (0) t+1), m − vol(V (0) t+1)o −pvol(st)# 9 ) + ∆)(cid:27) −qvol(v(0) t ) − ∆(cid:27) −qvol(v(0) t )(cid:21) t t t t = E(cid:20)min(cid:26)qvol(v(0) ) + ∆,qm − (vol(v(0) ≥ E(cid:20)min(cid:26)qvol(v(0) ) + ∆,qvol(v(0) )(cid:21) = E(cid:20)qvol(v(0) ) − ∆ −qvol(v(0) ) − 1(cid:19)(cid:21) = E(cid:20)qvol(v(0) )(cid:18)r1 − ∆ 2Ψ(st)2 − ∆2 Ψ(st)4(cid:21) ≥ Ψ(st) · E(cid:20) ∆ vol(v(0) t t t t )(cid:21) (8) where the last inequality comes from the Taylor expansion inequality √1 + x ≥ 1 + x 2 − x2, x ≥ −1. Similar to (2) we get E[(∆)2] = Xu∈V ≤ Xu∈V E[X 2 u] = Xu∈V λu · d 2 From (8) we derive now Var[Xu] + (E[Xu])2 = Xu∈V Var[Xu] + 0 = Xu∈V (E[X 2 u] − (E[Xu])2) = d · cut(st, V \ st) ≤ c · φt · d · vol(st) = c · φt · dΨ(st)2. E [Ψ(St+1) − Ψ(st) St = st] ≥ Ψ(st) ·(cid:18)− Ψ(st)2 (cid:19) ≥ − c · φt · d c · φt · d Ψ(st) . We now describe the adversary for the graphs that we use in our lower bound. We assume that we have initially two opinions and each of the two opinion is on n/2 nodes.Recall that we can assume that in round t + 1 the adversary knows the graph Gt as well as the distribution of the opinions over the nodes. The adversary generates Gt+1 as follows. c is a constant which is defined in Lemma A.3). • If st ≥ γ · n, the adversary creates a d-regular graph Gt+1 with two subsets st and V \ st such that the conductance of the cut(st, V \ st) is at most c · φt; According to Lemma A.3 such a graph always exist. • If St = st < γ · n, the adversary does not change the graph and sets Gt+1 = Gt. To show Theorem 1.2 we first define a new potential function g and bound the one step potential 2cd . Since g(·) is convex we obtain from Lemma 2.5, together with by drop. For x ≥ 0 we define g(x) = x2 Jensen's inequality that E [g (Ψ(St+1)) − g (Ψ(st)) St = st] ≥ g (E [Ψ(St+1) St = st]) − g (Ψ(st)) 1 2cd · (cid:18)Ψ(st) − ≥ ≥ −φt. Ψ(st) (cid:19)2 c · φt · d − (Ψ(st))2! In the following lemma we use some Martingale arguments to show that with a probability of at least one half vol(Sτ ′′ ) ≥ γd · n/2. This implies that no opinion vanished after τ ′′ w.p. 1/2, which yields Theorem 1.2. Lemma 2.6. Let s0 = n/2. Fix some constant γ < 1/4. Assume G1, G2, . . . is s sequence of graphs generated by the adversary defined above. Then P(cid:18)g(Ψ(Sτ ′′)) > 4c (cid:19) ≥ 2γ · n 1 2 . Proof. We define T ′ = min{τ ′′, min{t : vol(St) ≤ 2γdn/2}}, where we recall that τ ′′ is the first rounds so that Pτ ′′ t=1 φt ≥ bn.. We define φi Zt = g(Ψ(St)) +Xi≤t and show it the following that Zt∧T ′ is a sub-martingale with respect to the sequence S1, S2, . . . , where t ∧ T ′ = min{t, T ′}. 10 Case t < T ′: For any t < T ′ we have E[Zt+1∧T ′ St, . . . , S1] = E[Zt+1 St, . . . , S1] St, . . . , S1  g(Ψ(St+1)) + Xi≤t+1 = E = E [g(Ψ(St+1)) − g(Ψ(st)) St, . . . , S1] + g(Ψ(st)) + Xi≤t+1 ≥ −φt+1 + φi (cid:12)(cid:12)(cid:12)(cid:12)(cid:12)(cid:12) φi g(Ψ(st)) +Xi≤t  + φt+1 = Zt = Zt∧T ′, φi (9) where the last equality follows since t < T ′. Case t ≥ T ′: For t ≥ T ′ and we have E[Z(t+1)∧T ′ St, . . . , S1] = E[ZT ′ St, . . . , S1] = ZT ′ = Zt∧T ′, where the last equality follows since t ≥ T ′. Both cases together show that Zt∧T ′ is a sub-martingale. According to Theorem 1.2 we have T ′ < ∞. Hence we can apply the optional stopping-time Theorem (c.f. Theorem A.4), which results in We define By definition of St, we have St ≤ s0 and thus n 4c . E[Zt∧T ′] ≥ E[Z0] = p = P (cid:18)g(Ψ(ST ′)) ≤ 4c (cid:19) . 2γ · n g(Ψ(ST ′ )) ≤ g(Ψ(s0)) = n 4c . Thus E[Zτ ′′] ≤ n n 4c 4c +Pi≤τ ′′ φi. Hence we derive using T ′ ≤ τ ′′ that = E[Z0] ≤ E[ZT ′ ] φi ≤ p ·  + (1 − p) · + Xi≤T ′   + Xi≤τ ′′ + (1 − p) · ≤ 2p · γ · + b · n + 1, + (1 − p) · ≤ 2p · γ · 2γ · n 4c n 4c n 4c n 4c n 4c φi n 4c + Xi≤τ ′′ φi  where the last inequality follows from the definition of τ ′′ together with the fact that φi ≤ 1 for all i. Hence which equals 0 ≤ 2p · γ · n 4c − p · n 4c + b · n + 1 p · (1 − 2γ) · n 4c ≤ b · n + 1. Thus for γ < 1/4 and b < 1/(18c) we get p ≤ 1/2 and thus we have P (cid:0)g(Ψ(ST ′)) ≤ 2γ·n which yields the claim. 4c (cid:1) = p ≤ 1/2 In the following we observe that if the adversary is allowed to change the degrees, then the expected consensus time is super-exponential. Observation 1 (super exponential runtime). Let G1 = (V, E1), G2 = (V, E2), . . . be a sequence of graphs with n nodes, where the edges E1, E2, . . . are distributed by an adaptive adversary, then the expected consensus time is at least Ω((n/c)n/c) for some constant c. 11 Proof. The idea is the following. The initial network is a line and there are two opinions 0 and 1 distributed on first n/2 and last n/2 nodes respectively. Whenever one opinion i has fewer nodes than the other, the adversary creates a graph where only one edge is crossing the cut between both opinions and the smaller opinions forms a clique. Hence, the probability for the smaller opinion to decrease is O(1/n) and the probability for the bigger opinion to decrease is Ω(1). This can be coupled with a biased random walk on a line of n/4 nodes with the a transition probability at most 1/(n/4) = 4/n in one direction and at least 1/2 in the other. Consequently, there exists a constant c such that expected consensus time is Ω((n/c)n/c). The following observation shows that the bound of Theorem 1.1 for static regular graphs of O(n/φ) is tight for regular graphs if either the degree or the conductance is constant. Observation 2 (lower bound static graph). For every n, d ≥ 3, and constant φ, there exists a d-regular graph G with n nodes and a constant conductance such that the expected consensus time on G is Ω(n). Furthermore, for every even n, φ > 1/n, and constant d, there exists a (static) d-regular graph G with Θ(n) nodes and a conductance of Θ(φ) such that the expected consensus time on G is Ω(n/φ). Proof. For the first part of the claim we argue that the meeting time of a d-regular graphs is Ω(n) [2]. The claim follows from the duality between coalescing random walks and the voter model. For the second part of the claim we construct a random graph G′ with n′ = Θ(n · φ) nodes and a constant conductance (See, e.g., [3]). We obtain G by replacing every edge (u, v) of G′ with a path connecting u and v of length ℓ = Θ(1/φ) and ℓ mod d = 0. Additionally, we make G d-regular by adding ℓ(d − 2)/d nodes to every path in such a way that the distance between u and v is maximised. We note that the obtained graph G has conductance Θ(φ), Θ(n) nodes, and is d-regular. The meeting time of G′ is Ω(n′) [2]. Taking into account that traversing every path in G takes in expectation ℓ2 = Θ(1/φ2) rounds, the expected meeting time in G is at least Ω(n′ · ℓ2) = Ω(n/φ). This yields the claim. 3 Analysis of the Biased Voter Model In this section, we prove Theorem 1.3. We show that the set St of nodes with the preferred opinion grows roughly at a rate of 1 + Θ(φt), as long as St or S′ t has at least logarithmic size. For the analysis we break each round down into several steps, where exactly one node which has at least one neighbour in the opposite set is considered. Instead of analysing the growth of St for every round we consider larger time intervals consisting of a suitably chosen number of steps. We change the process slightly by assuming that there is always one node with the preferred opinion. If in some round the preferred opinions vanishes totally, Node 1 is set back to the preferred opinion. Symmetrically, if all other opinions vanishes, then Node 1 is set to Opinion 1. Note that this will only increase the runtime of the process. The proof unfolds in the following way. First, we define formally the step sequence S . Second, we define (Definition 1) a step sequence S to be good if, intuitively speaking, the preferred opinion grows quickly enough in any sufficiently large subsequence of S . Afterward, we show that if S is a good step sequence, then the preferred opinion prevails in at most τ ′′′ rounds (Lemma 3.2). Finally, we show that that S is indeed a good step sequence w.h.p. (Lemma 3.3). We now give some definitions. Again, we denote by St the random set of nodes that have the preferred t = V \ St. For a fixed time step t we write st and s′ t. t which are adjacent to at least one node from st. t. For each u ∈ V , let λu,t be the number of edges incident with t), or equivalently, the number of u's neighbours that have a different opinion opinion right after the first t rounds, and let S′ We define the boundary ∂st as the subset of nodes in s′ We use the symmetric definition for ∂s′ u crossing the cut cut(st, s′ than u's before round t. We divide each round t into st + s′ t steps, in every step a single node v from either ∂st or ∂s′ t randomly chooses a neighbour u and adopts its opinion with the corresponding bias. Note that we assume that v sees u's opinion referring to beginning of the round, even if was considered before v and changed its opinion in the meantime. It is convenient to label the steps independently of the round in which they take place. Hence, step i denotes the i-th step counted from the beginning of the first round. Also ui refers to the node which considered in step i and λi = λui,t. We define the indicator variable oi with oi = 1 if ui has the preferred opinion and oi = 0 otherwise. Let Λ(i) = i Xj=1 (1 − oi) · λi and Λ′(i) = i Xj=1 oi · λi. 12 Unfortunately, the order in which the nodes are considered in a round is important for our analysis and cannot be arbitrarily. Intuitively, we order the nodes in st and s′ t such that sum of the degrees of nodes which are already considered from st and the sum of the degrees of nodes already considered from s′ t differs by at most d, i.e., Λi − Λ′ i ≤ d. The following rule determines the node to be considered in step j + 1: if Λ(j) ≤ Λ′(j), then the (not jet considered) node v ∈ ∂st is with smallest identifier is considered. Otherwise the node v ∈ ∂st is with smallest identifier is considered. Note that at the first step i of any round we have Λi = Λ′ i. This guarantees that (10) holds. The step sequence S is now defined as a sequence of tuples, i.e., S = (u1, Z1), (u2, Z2), . . . , where Zj = 1 if uj changed its opinion in step j and Zj = 0 otherwise for all j ≥ 1. Observe that when given the initial assignment and the sequence up to step i, then we know the configuration Ci of the system, i.e., the opinions of all nodes at step i and in which round step i occurred. (10) In our analysis we consider the increase in the number of nodes with the preferred opinion in time intervals which contain a sufficiently large number of steps, instead of considering one round after the other. The following definitions define these intervals. For all i, k ≥ 0 where Ci is fixed, we define the random variable Si,k := min{j : Λj − Λi ≥ k}, which is the first time step such that nodes with a degree-sum of at least k were considered. Let Ii,k = [i + 1, Si,k] be the corresponding interval where we note that the length is a random variable. We proceed by showing an easy observation. Observation 3. The number of steps in the interval Ii,k is at most 2k + 2d, i.e., Ii,k ≤ 2k + 2d. Furthermore, Λ′(Si,k) − Λ′(i) ≤ k + 2d. Proof. Assume, for the sake of contradiction, that Ii,k > 2k + 2d. This implies, by definition of Ii,k = [i + 1, Si,k], that the number of edges of the preferred opinion considered in I = [i + 1, 2k + 2d] is strictly less than k, i.e., Λ(i + 2k + 2d) − Λ(i) < k. We have Λ′(i + 2k + 2d) − Λ(i + 2k + 2d) > Λ′(i + 2k + 2d) − (Λ(i) + k) ≥ Λ′(i) + 2k + 2d − k − (Λ(i) + k) = Λ′(i) − Λ(i) + 2d ≥ −d + 2d ≥ d, (11) which contradicts (10). Hence Ii,k ≤ 2k + 2d. k + 2d. This implies that We now prove the second part of the lemma. Assume, for the sake of contradiction, Λ′(Si,k)− Λ′(i) > Λ′(Si,k) − Λ(Si,k) > Λ′(i) + k + 2d − Λ(Si,k) ≥ Λ′(i) + k + 2d − (Λ(i) + k) = Λ′(i) − Λ(i) + 2d ≥ −d + 2d ≥ d, (12) which contradicts (10). Hence Λ′(Si,k) − Λ′(i) ≤ k + 2d. Fix Ci and let Xi,k be the total number of times during interval Ii,k that a switch from a non-preferred i,k similarly for the reverse switches. Finally, we define i,k; thus Yi,k is the increase in number of nodes that have the preferred opinion during opinion to the preferred one occurs; and define X ′ Yi,k = Xi,k − X ′ the time interval Ii,k. Define ℓ = 132β log n (1−α1)2 and β′ = 600d α1·(1−α1)2 . In the following we define a good sequence. Definition 1. We call the sequence S of steps good if it has all of the following properties for all i ≤ T ′ = 2β′ · n. Consider the first T ′ steps of S (fix CT ′ ). Then, (a) Y0,T ′ ≥ 2n. (The preferred opinion prevails in at most T ′ steps) (b) Y0,i + S0 > 1. (The preferred opinion never vanishes) (c) For any 1 ≤ k ≤ T ′ we have Yi,k ≥ −ℓ. (# nodes of the pref. opinion never drops by ℓ) (d) For any ℓ ≤ γ ≤ T ′, we have Yi,k > γ, where k = γ · β′. (# nodes of the pref. opinion increases) 13 This definition allows us to prove in a convenient way that a step sequence S is w.h.p. good: For each property, we simply consider each (sufficiently large) subsequence S separately and we show that w.h.p. S has the desired property. We achieve this by using a concentration bound on Yi,k which we establish in Lemma 3.1. Afterward, we take union bound over all of these subsequences and properties. Using the union bound allows us to show the desired properties in all subsequences in spite of the emerging dependencies. This is done in Lemma 3.2. We now show the concentration bounds on Yi,k. These bounds rely on the Chernoff-type bound established in Lemma A.5. This Chernoff-type bound shows concentration for variables having the property that the sum of the conditional probabilities of the variables, given all previous variables, is always bounded (from above or below) by some b. The bound might be of general interest. Lemma 3.1. Fix configuration Ci. Then, (a) For k = γ α1·(1−α1)2 with γ ≥ 1 it holds that 256d Pr (Yi,k < γ) ≤ exp (−γ) . (b) For k ≥ 0, any b′ = α1 · (k + 2d)/d, and any δ > 0 it holds that Proof. First we show a lower bound for Xi,k and an upper bound for X ′ i,k. Pr (Yi,k < −(1 + δ)b′) ≤ exp(cid:16) eδ (1+δ)1+δ(cid:17)b′ . For 1 ≤ j ≤ 2k + 2d, let Aj be the event that ui+j switches its opinion from any opinion other than the preferred opinion to the preferred one. Furthermore, for 1 ≤ j ≤ 2k + 2d, let Zj =(1 0 if i + j ≤ Si,k and Aj otherwise Define Pj =(Pr(Zj = 1 Z1, . . . , Zj−1) = λi+j /d It follows that Xi,k =Pj Zj. We set B =Pj Pi. We derive 0 i + j ≤ Si,k and Aj otherwise B =Xj Pi = Xs∈Ii,k (1 − os)λs/d = (Λ(Si,k) − Λ(i))/d ≥ k/d, by definition of Ii,k. From Lemma A.5(b) with b∗ = k/d ≤ B we obtain for any 0 < δ < 1, that Pr(Xi,k < (1 − δ)b∗) < e−b∗·δ2/2 (13) We now use a similar reasoning to bound X ′ j be the event that ui+j switches its opinion from the preferred opinion to any other opinion. Define for 1 ≤ j ≤ 2k + 2d the variables Z ′ j instead of Aj. And similarly, define for 1 ≤ j ≤ 2k + 2d the variables P ′ j, . . . , Z ′ 1 instead of Zj, . . . , Z1. In the same spirit as before one j similar to Zj but using A′ j similar as Pj but using Z ′ i,k. For 1 ≤ j ≤ 2k + 2d let A′ can define B′ =Pj P ′ B′ =Xj i . We derive P ′ i ≤ Xs∈Ii,k os · α1 · λs/d = α1 · (Λ′(Si,k) − Λ′(i))/d ≤ α1 · (k + 2d)/d, where the last inequality follows from Observation 3. Using a similar reasoning for X ′ i,k and applying Lemma A.5(a) with b′ = α1·(k+2d) d δ > 0, ≥ B′, yields for Pr(cid:0)X ′ To prove part (a) we now combine (13) and (14) as follows. Since k ≥ 16d/(1 − α1), for δ = (1 − α1)/8, we have that w.p. at least 1 − e−b∗·δ2/2 −(cid:16) i,k > (1 + δ)b′(cid:1) <(cid:16) (1+δ)1+δ(cid:17)b′ that (14) eδ eδ (1+δ)1+δ(cid:17)b′ 14 Yi,k = Xi,k − X ′ i,k k k k 2d ≥ k (cid:19) ≥ (1 − δ)b∗ − (1 + δ)b′ d (cid:18)1 − δ − (1 + δ)α1 − (1 + δ) ≥ d (cid:18)1 − α1 − 2δ − (1 + δ) k (cid:19) k (cid:19) d (cid:18)1 − α1 − (1 − α1)/4 − (1 + δ) (1 − α1 − (1 − α1)/4 − (1 − α1)/4) ≥ k d 2d 2d ≥ ≥ (1 − α1) = γ 32 α1·(1−α1) k 2d > γ. We proceed by bounding 1 − e−b∗·δ2/2 −(cid:16) eδ eδ . Let p = e−b∗·δ2/2 +(cid:16) (1+δ)1+δ(cid:17)b′ (1+δ)1+δ(cid:17)b′ p ≤ e−b∗·δ2/2 +(cid:16) ≤ e−b∗·δ2/2 + e−b′·δ2/2 = e−b∗·(1−α1)2/128 + e−b′·(1−α1)2/128 ≤ 2e−α1·(1−α1)2·k/(128d) ≤ e−α1·(1−α1)2·k/(266d) = e−γ, (15) (16) eδ (1+δ)1+δ(cid:17)b′ . We have where we used that k ≥ 256d α1·(1−α1)2 . Part (a) follows from (15) and (16). We now prove part (b). Since we used that Yi,k ≥ −X ′ i,k, the bound from (14) implies Pr(Yi,k < −(1 + δ)b′) ≤ Pr(X ′ i,k > (1 + δ)b′) <(cid:16) eδ (1+δ)1+δ(cid:17)b′ Hence, part (b) of the lemma follows. This completes the proof of Lemma 3.1. The following two lemmas imply the theorem. Lemma 3.2. Let S be a step sequence. Then S is good with high probability. Proof. We show for every property of Definition 1 that it holds with high probability. Fix an arbitrary i ≤ T ′. (a) We derive from Lemma 3.1(a) with k = 2n · β′ that Pr(Y0,k < 2n) ≤ e−2n ≤ n−β. (b) Follows from (c). (c) Fix an arbitrary k ≤ T ′. We distinguish between two cases (i) Case k ≤ β · log n · β′. We derive from Lemma 3.1(b) the following. For k ≥ 0, any b′ = α1 · (k + 2d)/d ≤ 300β log n (1−α1)2 = ℓ/2, and any δ > 0 it holds that Pr (Yi,k < −(1 + δ)b′) ≤ exp(cid:16) We distinguish once more between two cases. eδ (1+δ)1+δ(cid:17)b′ . 15 Pr (Yi,k < −ℓ) ≤ Pr (Yi,k < −2b′) ≤ Pr (Yi,k < −(1 + δ)b′) ≤ exp(cid:0)−δ2b′/3(cid:1) ≤ n−β. (1+δ)1+δ(cid:17)b′ ≤ exp(cid:16) eδ • Otherwise, we have b′ ≤ 3β log n < 4β log n. Set δ = 4β log n (1+δ)1+δ(cid:17)b′ P r (Yi,k < −ℓ) ≤ Pr (Yi,k < −(1 + δ)b′) ≤ exp(cid:16) eδ b′ > 1. We have ≤ exp (−δb′/3) ≤ n−β. • If q 3β log n b′ < 1 set δ =q 3β log n b′ < 1. We have Thus, the claim follows. n−β. (ii) Case k > β · log n· β′. We derive from Lemma 3.1(a) that Pr(Yi,k < −ℓ) ≤ Pr(Yi,k < β log n) < Hence, in all cases we have Pr(Yi,k < −ℓ) ≤ n−β. (d) We derive from Lemma 3.1(a) with k = z · β′ that Pr(Yi,k < z) < exp(−z) ≤ n−β. Since 0 < α1 < 1, we have that T ′ ≤ n3. The number of events in Definition 1 is bounded by 5T ′2 ≤ n7. Thus choosing, β ≥ 8, and taking union bound over all these events yields the claim. Lemma 3.3. If S is a good step sequence, then in at most T ′ time steps, the preferred opinion prevails and the T ′ time steps occur before round τ ′′′. Proof. Recall, that we assume that if in some round the preferred opinions vanishes, then after this round, the opinion of some fixed node switches spontaneously. Similarly, if in some round the preferred opinion prevails, then after this round, the opinion of some fixed node switches spontaneously to an arbitrary other opinion.the preferred opinion never vanishes. This process P ′ diverges from the original process P only after the first step where either the preferred opinion prevails or vanishes. From (a) and (b) of the definition of a good sequence it follows that the preferred opinion prevails in P ′ after T ′ steps. It is easy to couple both process so that the good opinion also prevails in the original process P . t) ≥ d· min{St,S′ It remains to argue that the T ′ time steps happen before round τ ′′′. Using the definition of the conductance, we can lower bound the number of steps in any round t by cut(St, S′ i}· φt. We then consider intervals of sufficient length in which the size of the preferred doubles as long as its size is below n/2. Afterward, one can argue that size of all the non preferred opinions halves every interval. We now give some intuition for the remainder of the proof. Consider the following toy case example of a static graphs with α1 = 0 (rumor spreading). The length of an interval required for the preferred S with s ≤ n/3 to double in expectation is bounded by 1/φ. In our setting, we need to handle two main difference w.r.t. the toy case example. First, the number of nodes with the preferred opinion can reduce by up to β log n (Definition 1(c)). Since β is constant, this can be easy compensated by slightly longer intervals. Second, the graph is dynamic as opposed to static. To address this we 'discretize', similarly as before, rounds into consecutive phases which ensure that sum of the φt for rounds t in this phase is at least 1. Thus, in our toy example one requires 1 phases in expectation. We proceed by discretizing the rounds into phases. Phase i starts at round τ (i) = min{t :Pt j=1 φj ≥ 2i} for i ≥ 0 and it ends at round τ (i + 1) − 1. Since φj ≤ 1 for all j ≥ 0 we have τ (0) < τ (1) < . . . and Pτ (i+1)−1 φ(j) ≥ 1 for i ≥ 0. We now map the steps of S to rounds. For this we define the check point tj to be the following round for j ≤ jmax = 4 log n + 1. j=τi 0 τ (12ℓ · β′/d) τ (12ℓ · β′/d + (j − 1) · 24β′/d) τ (24ℓ · β′/d + (jmax − 1) · 24β′/d) if j = 0 if j = 1 if 2 ≤ j ≤ 4 log n if j = jmax tj =  Given any good sequence S , we show by induction over j that the following lower bounds on the size of the preferred opinion at these check points. More concretely, define for all j ≤ jmax that 16 ζ(j) = 0 2ℓ min{2ℓ · 2j−2, n/2} min{n − 2log(n/2)−(j−2 log n), n − 2ℓ} n if j = 0 if j = 1 if 2 ≤ j ≤ 2 log n if 2 log n < j ≤ 4 log n if j = jmax   We now show for all j ≤ jmax that stj ≥ ζ(j), (17) We consider each of the cases depending of the size of j w.r.t. (17). The induction hypothesis j = 0 holds trivially. Suppose the claim holds for j − 1 for j ≥ 1. We assume w.l.o.g. the following about S : there is no step t before round tj with st ≥ ζ(j) + ℓ since by Definition 1(c) this implies that stj ≥ ζ(j) which yields the inductive step. This assumption, implies that for all t ≤ tj we have st < ζ(j) + ℓ. On the other hand, by induction hypothesis and Definition 1(c) we have ζ(j − 1) − ℓ ≤ st. Thus, we assume in the following st ∈ [ζ(j − 1) − ℓ, ζ(j) + ℓ] (18) We now distinguish between the following cases based on j. • j = 1 : In every step t ∈ (0, t1] the number of edges crossing the cut is at least φt · d and hence the number of edges crossing the cut in the interval (0, t1] is at least Pt1 i=1 φi · d ≥ 12ℓ · β′. Let k = 3ℓ · β′. Definition 1(d) implies that Y1,k > 3ℓ. Hence, by Definition 1(c) we have st1 ≥ ζ(1) as desired. • 2 ≤ j ≤ 2 log n : In every step t ∈ (tj−1, tj] we have, by (18), that the number of edges crossing the cut is at least φ· d· (min{st,s′ t}− ℓ) ≥ φ· d· min{ζ(j − 1)− ℓ, n/2− ℓ} ≥ φ· d· (ζ(j − 1)− ℓ) ≥ φt · d· ζ(j − 1)/2. Hence the number of edges crossing the cut in the interval (tj−1, tj] is at least 12ζ(j − 1) · β′. Let k = 3ζ(j − 1) · β′. Definition 1(d) implies that Ytj−1,k ≥ 3ζ(j − 1) ≥ ζ(j) + ℓ. Hence, by Definition 1(c) we have stj ≥ ζ(j). • 2 log n < j ≤ 2 log n : In every step t ∈ (tj−1, tj] we have, by (18), that the number of edges crossing the cut is at least φt · d · (min{st,s′ t} − ℓ) ≥ φ · d · (n − ζ(j) − ℓ) ≥ φ · d · (n − ζ(j))/2. Hence the number of edges crossing the cut in the interval (tj−1, tj] is at leastPtj i=tj−1+1 φi· d· (n− ζ(j))/2 ≥ 12(n−ζ(j))·β′. Let k = 3(n−ζ(j))·β′. Definition 1(d) implies that Ytj−1,k ≥ 3(n−ζ(j)) ≥ (n − ζ(j)) + ℓ. Hence, by Definition 1(c) we have stj ≥ min{ζ(j − 1) + (n − ζ(j)), n − 2ℓ} ≥ ζ(j). • jmax : In every step t ∈ (tj−1, tj] we have, by (18), that the number of edges crossing the cut at any time step is at least φt · d. Hence the number of edges crossing the cut in the interval (tj−1, tj] is at least d ≥ 12ℓ · β′. Let k = 3ℓ · β′. Definition 1(d) implies that Ytjmax −1,k ≥ 3ℓ. Hence, by Definition 1(c) we have stjmax ≥ n = ζ(jmax). This completes the proof of (17). We have tjmax = τ (24ℓ · β′ + jmax · 24β′/d) ≤ 4 (24ℓ · β′ + (jmax − 1) · 24β′/d) ≤ τ ′′′, which yields the proof. Proof of Theorem 1.3. The claim follows from Lemma 3.2 together with Lemma 3.3. 17 References [1] M. A. Abdullah and M. Draief. Global majority consensus by local majority polling on graphs of a given degree sequence. Discrete Applied Mathematics, 180:1 -- 10, 2015. [2] D. Aldous and J. Fill. Reversible markov chains and random walks on graphs, 2002. Unpublished, http://www.stat.berkeley.edu/~aldous/RWG/book.html. [3] N. Alon, O. Schwartz, and A. Shapira. An elementary construction of constant-degree expanders. Comb. Probab. Comput., 17(3):319 -- 327, May 2008. [4] C. Avin, M. Koucký, and Z. Lotker. How to explore a fast-changing world (Cover time of a simple random walk on evolving graphs). In Proceedings of the 35th International Colloquium on Automata, Languages and Programming (ICALP), pages 121 -- 132, 2008. [5] Y. Azar, A. Broder, A. Karlin, and E. Upfal. Balanced allocations. SIAM J. Comput., 29(1):180 -- 200, 1999. [6] C. Cooper, R. Elsässer, H. Ono, and T. Radzik. Coalescing random walks and voting on connected graphs. SIAM J. Discrete Math., 27(4):1748 -- 1758, 2013. [7] C. Cooper, R. Elsässer, and T. Radzik. The power of two choices in distributed voting. In Proceedings of the 41st International Colloquium on Automata, Languages and Programming (ICALP), pages 435 -- 446, 2014. [8] C. Cooper, R. Elsässer, T. Radzik, N. Rivera, and T. Shiraga. Fast consensus for voting on general expander graphs. In Proceedings of the 29th International Symposium on Distributed Computing (DISC), pages 248 -- 262, 2015. [9] J. Cruise and A. Ganesh. Probabilistic consensus via polling and majority rules. Queueing Systems, 78(2):99 -- 120, 2014. [10] J. Díaz, L. Goldberg, G. Mertzios, D. Richerby, M. Serna, and P. Spirakis. Approximating fixation probabilities in the generalized moran process. Algorithmica, 69(1):78 -- 91, 2014. [11] P. Donnelly and D. Welsh. Finite particle systems and infection models. Mathematical Proceedings of the Cambridge Philosophical Society, 94:167 -- 182, 1983. [12] R. Elsässer, T. Friedetzky, D. Kaaser, F. Mallmann-Trenn, and H. Trinker. Efficient k-party voting with two choices. ArXiv e-prints, Feb. 2016. [13] G. Giakkoupis. Tight bounds for rumor spreading in graphs of a given conductance. In Proceedings of the 28th International Symposium on Theoretical Aspects of Computer Science (STACS), pages 57 -- 68, 2011. [14] G. Giakkoupis, T. Sauerwald, and A. Stauffer. Randomized rumor spreading in dynamic graphs. In Proceedings of the 41st International Colloquium on Automata, Languages and Programming (ICALP), pages 495 -- 507, 2014. [15] Y. Hassin and D. Peleg. Distributed probabilistic polling and applications to proportionate agree- ment. Information and Computation, 171(2):248 -- 268, 2001. [16] R. Holley and T. Liggett. Ergodic theorems for weakly interacting infinite systems and the voter model. The Annals of Probability, 3(4):643 -- 663, 1975. [17] B. Houchmandzadeh and M. Vallade. The fixation probability of a beneficial mutation in a geo- graphically structured population. New Journal of Physics, 13(7):073020, 2011. [18] M. Kearns and J. Tan. Biased voting and the democratic primary problem. In Proceedings of the 4th International Workshop on Internet and Network Economics (WINE), pages 639 -- 652, 2008. [19] F. Kuhn, N. Lynch, and R. Oshman. Distributed computation in dynamic networks. In Proceedings of the 42nd ACM Symposium on Theory of Computing (STOC), pages 513 -- 522, 2010. 18 [20] H. Lam, Z. Liu, M. Mitzenmacher, X. Sun, and Y. Wang. Information dissemination via random walks in d-dimensional space. In Proceedings of the 23rd Annual ACM-SIAM Symposium on Discrete Algorithms (SODA), pages 1612 -- 1622, 2012. [21] N. Lanchier and C. Neuhauser. Voter model and biased voter model in heterogeneous environments. Journal of Applied Probability, 44(3):770 -- 787, 2007. [22] T. Liggett. Interacting Particle Systems. Springer Berlin Heidelberg, 1985. [23] G. Mertzios and P. Spirakis. Strong bounds for evolution in networks. In Proceedings of the 40th In- ternational Colloquium on Automata, Languages and Programming (ICALP), pages 669 -- 680, 2013. [24] M. Mitzenmacher and E. Upfal. Probability and Computing: Randomized Algorithms and Proba- bilistic Analysis. Cambridge Univ. Press, 2005. [25] R. Motwani and P. Raghavan. Randomized Algorithms. Cambridge University Press, 1995. [26] T. Nakata, H. Imahayashi, and M. Yamashita. A probabilistic local majority polling game on weighted directed graphs with an application to the distributed agreement problem. Networks, 35(4):266 -- 273, 2000. [27] R. Oliveira. On the coalescence time of reversible random walks. Transactions of the American Mathematical Society, 364(4):2109 -- 2128, 2012. [28] Y. Peres, A. Sinclair, P. Sousi, and A. Stauffer. Mobile geometric graphs: Detection, coverage and percolation. Probability Theory and Related Fields, 156(1-2):273 -- 305, 2013. 19 A Auxiliary Claims Lemma A.1. Let Xi and Yi be the random variables defined in the proof of Lemma 2.1. Let f (·) be a concave and continuous function. We have E [f (Pi Xi)] ≤ E [f (Pi Yi)] . Proof. We show by induction over i that the variables E[f (Y1 + ··· + Yi−1 + Xi + ··· + Xk)] ≤ E[f (Y1 + ··· + Yi + Xi+1 + ··· + Xk)]. Let Z = Y1 + ··· + Yi−1 + Xi+1 + ··· + Xk. In step i → i + 1 we have = λi λi λi di = E[f (Z + Xi)] E[f (Y1 + ··· + Yi−1 + Xi + ··· + Xk)] di(cid:19) E[f (Z)] E[f (Z + di] +(cid:18)1 − = λiE(cid:20) f (Z + di) di(cid:19) E [f (Z)] (cid:21) +(cid:18)1 − = λiE(cid:20) f (Z + di) − f (Z) (cid:21) + E [f (Z)] (cid:21) + E [f (Z)] ≤ λiE(cid:20) f (Z + λi) − f (Z) = E[f (Y1 + ··· + Yi + Xi+1 + ··· + Xk)], di λi di where the last inequality follows from the concavity of f (·). Lemma A.2. Let Z1, . . . , Zn be independent random variables and Z = Pi Zi. E[Z 3] =Pi(cid:0) E[Z 3 Proof. In the following we make use of E[Pi Zi] = 0. We derive i ] · E[Zi] + 2 E[Zi]3(cid:1). i ] − 3 E[Z 2 If E[Z] = 0, then E(cid:2)Z 3(cid:3) = E Xi,j,k E ZiXj,k =Xi i(cid:3) + 3Xi =Xi E(cid:2)Z 3 E [Zi] Xj, j6=i +Xi i(cid:3) + 3Xi =Xi E(cid:2)Z 3 E [Zi] Xj, j6=i +Xi i(cid:3) − 3Xi =Xi E(cid:2)Z 3 E [Zi] Xj j6=i +Xi i(cid:3) − 3Xi =Xi E(cid:2)Z 3 i(cid:3) − 3Xi =Xi E(cid:2)Z 3 ZiZjZk  ZjZk  i(cid:3) E Zj  Xj, j6=i E(cid:2)Z 2  E [Zj] E Zk  Xk, k6=i,j  E(cid:2)Z 2 i(cid:3) (0 − E[Zi]) E [Zj] (0 − E[Zi] − E[Zj]) E(cid:2)Z 2 E [Zj] (− E[Zj]) E(cid:2)Z 2 E(cid:2)Z 2 i(cid:3) E [Zi] + 2Xi i(cid:3) E [Zi] + 2Xi i(cid:3) E [Zi] +Xi 20 E [Zi] (− E[Zi]) Xj j6=i E [Zj] E [Zi] (− E[Zi])(− E[Zi]) E[Zi]3. We now show d-regular graphs with a cut of size Θ(φtdn) exist indeed. Lemma A.3. Let 1 nd ≤ φ ≤ 1. Let 0 < γ < 1 be some constant. Let d ≥ 6 be an even integer. For any integer n′ ∈ [γn, n/2] there exists a d-regular graph G = (V, E) with n nodes and the following property. There is a set S ⊂ V with S = n′ such that cut(S, V \ S) = Θ(φdn). Moreover, there are at least n′/2 nodes without any edges in cut(S, V \ S). Proof. In the following we create two d-regular graphs G′ and G′′ and connect them to a d-regular graph G such that the cut size is Θ(φdn). Let G′ = (V ′, E′) be the circulant graph C⌊d/2⌋ n′}. Let G′′ = (V ′′, E′′) be the circulant graph C⌊d/2⌋ n−n′}. We now connect G′ and G′′. W.l.o.g. φ ≤ 1/d. The case φ > 1/d is analogue. We choose k such that we have 2 ≤ k < n′/2 and k = Θ(φdn′). Let S′ = {v′ 1, , . . . , , v′ i+1) i+1). Note that G′(G′′ respectively) is still connected. Furthermore, the with 1 ≤ i ≤ k − 1 and (v′′ i , v′′ k have degree d − 1 and all other vertices of S′ ∪ S′′ have degree d − 2. One can vertices v′ easily add (2k − 2) edges such that (i) one endpoint of every edge is in V ′ and one in V ′′, and (ii) all vertices in G′ and G′′ have degree d. Note that the obtained graph G is connected and the cut cut(V ′, V \V ′) contains (2k−2) = Θ(φdn′) n−n′ with V ′ = {v′′ 1 , . . . , v′′ k}. Now we remove all edges (v′ k} and let S′′ = {v′′ with V ′ = {v′ 1, v′ k, v′′ 1 , and v′′ 1, . . . , v′ edges. The claim follows directly. n′ 1 , . . . , v′′ i, v′ Theorem A.4 ( [24, Theorem 12.2]). If Z0, Z1, . . . is a martingale with respect to X1, X2, . . . and if T is a stopping time for X1, X2, . . . , then E[Zt] = E[Z0] whenever one of the following holds: • The Zi are bounded, so there is a constant for all i, Zi ≤ c; • T is bounded; • E[T ] ≤ ∞, and there is a constant c such that E[Zt+1 − ZtX1, . . . Xt] < c; A.1 A Chernoff-type bound The following lemma bounds the sum of (dependent) binary random variables, under the assumption that the sum of the conditional probabilities of the variables, given all previous variables, is always bounded (from above or below) by some b. The bounds are the same as the ones for independent variables but use b in place of µ. The bound can be seen as a generalisation of [5]. The proof follows the proof of the independent case. Lemma A.5 (Chernoff Bound for Dependent Setting). Let Z1, Z2, . . . , Zℓ be a sequences of binary random variables, and for each 1 ≤ i ≤ ℓ, let pi = Pr(Zi = 1 Z1, . . . , Zi−1). Let Z =Pi Zi, B =Pi pi. (a) For any b ≥ 0 with Pr(B ≤ b) = 1, it holds for any δ > 0 that eδ (1 + δ)1+δ(cid:19)b (b) For any b ≥ 0 with Pr(B ≥ b) = 1, then for any 0 < δ < 1 it holds that Pr(Z > (1 + δ) · b) <(cid:18) . Pr(Z < (1 − δ)b) < e−bδ2/2. Proof. The proof follows the proof of the Chernoff bound given in [25]. However, the random variables {Zi : 1 ≤ i ≤ k} are not independent. For any positive real t we have Pr(Z ≥ (1 + δ)b) = Pr(exp(tZ) ≥ exp(t(1 + δ)b)). Thus, by applying Markov inequality we derive We now bound E[exp(tZ)]. By law of total expectation and p1 = Pr(Z1 = 1) we get Pr(Z ≥ (1 + δ)b) < E[exp(tZ)] exp(t(1+δ)b) . (19) E[exp(tZ)] = E[exp(tZ)Z1 = 1] Pr(Z1 = 1) + E[exp(tZ)Z1 = 0] Pr(Z1 = 0) = E[exp(tZ)Z1 = 1]p1 + E[exp(tZ)Z1 = 0](1 − p1) 21 k k Repeating this inductively for the variables Z2, . . . , Zk yields k k Zi!(cid:12)(cid:12)(cid:12)(cid:12)(cid:12) Zi!(cid:12)(cid:12)(cid:12)(cid:12)(cid:12) Z1 = 0# (1 − p1) Z1 = 1# exp(t)p1 + E"exp t = E"exp t Xi=2 Xi=2 Zi!(cid:12)(cid:12)(cid:12)(cid:12)(cid:12) Zi)(cid:12)(cid:12)(cid:12)(cid:12)(cid:12) Z1 = 0#) (p1exp(t) + 1 − p1). ≤ max(E"exp(t Xi=2 Xi=2 (Piexp(t) + 1 − Pi) =Yi E[exp(tZ)] <Yi Z1 = 1# , E"exp t (1 + Pi(exp(t) − 1)). Using 1 + x < ex and rearranging gives E[exp(tZ)] < exp((exp(t) − 1)b). Plugging this into Eq. (19) yields Claim (a). Claim (b) can be proven analogously. 22
1309.1747
1
1309
2013-09-06T19:29:43
Stochastic Agent-Based Simulations of Social Networks
[ "cs.SI", "physics.soc-ph" ]
The rapidly growing field of network analytics requires data sets for use in evaluation. Real world data often lack truth and simulated data lack narrative fidelity or statistical generality. This paper presents a novel, mixed-membership, agentbased simulation model to generate activity data with narrative power while providing statistical diversity through random draws. The model generalizes to a variety of network activity types such as Internet and cellular communications, human mobility, and social network interactions. The simulated actions over all agents can then drive an application specific observational model to render measurements as one would collect in real-world experiments. We apply this framework to human mobility and demonstrate its utility in generating high fidelity traffic data for network analytics.
cs.SI
cs
Stochastic Agent-Based Simulations of Social Networks Garrett Bernstein and Kyle O'Brien MIT Lincoln Laboratory; 244 Wood Street; Lexington, MA 02421 (garrett.bernstein, kyle.obrien)@ll.mit.edu Social Keywords: agent-based, mixed- membership, activity model, observational model, human mobility networks, 3 1 0 2 p e S 6 ] I S . s c [ 1 v 7 4 7 1 . 9 0 3 1 : v i X r a Abstract The rapidly growing field of network analytics requires data sets for use in evaluation. Real world data often lack truth and simulated data lack narrative fidelity or statistical gener- ality. This paper presents a novel, mixed-membership, agent- based simulation model to generate activity data with narra- tive power while providing statistical diversity through ran- dom draws. The model generalizes to a variety of network ac- tivity types such as Internet and cellular communications, hu- man mobility, and social network interactions. The simulated actions over all agents can then drive an application specific observational model to render measurements as one would collect in real-world experiments. We apply this framework to human mobility and demonstrate its utility in generating high fidelity traffic data for network analytics. 1 1. INTRODUCTION Understanding phenomena in real world networks is a prominent field of research in many areas. There are a wide variety of inferential tasks on phenomena in communica- tion, social, and biological networks; for example, email traf- fic between employees of a company [4], vehicle traffic be- tween physical locations [17], collaborations between sci- entists [14], protein-protein interactions [20]. These studies range from clustering nodes into discrete communities to anomaly detection to inferring attributes on individual nodes to searching for specific activity embedded in background population clutter. The analytical approaches taken to study networks require vast amounts of complex, truthed data for algorithmic verification and there is currently a dearth of suf- ficient network data. We explore the causes of this data prob- lem and introduce our solution: a novel, two-tiered model that addresses drawbacks in current options. The first tier is an agent-based, mixed-membership, activity model that is easy to parametrize and abstractly generates agents' actions over time. The second tier is an application specific obser- 1This work is sponsored by the Assistant Secretary of Defense for Re- search & Engineering under Air Force Contract #FA8721-05-C-0002. Opin- ions, interpretations, conclusions and recommendations are those of the au- thor and are not necessarily endorsed by the United States Government vational model that supplies researchers with the simulated sensor data necessary to conduct experiments. Researchers face a trilemma of inadequate data from real world datasets, statistical simulation models, and agent-based simulation models. Large-scale real world data sets are ex- pensive to collect and difficult to obtain high fidelity ground truth for. Statistical models, such as Erods-R´enyi, Chung-Lu, and blockmodels, have parameters that are easy to specify and allow for simple replication of large-scale data sets. What is often missing, however, is the ability to encode narratives into the data because there is no sense of individual agents, just in- teractions between nodes. Hand-crafted agent-based models address this problem by allowing for narratives in the sense of specific actions taken by an agent throughout time. Those networks, however, may not result in the desired aggregate statistical behavior and are usually difficult to adapt to other applications. Additionally, generating network data is only half of the modeling problem. In the real world, data sets are not deliv- ered as clean networks with nodes and edges. Instead, algo- rithms must process them in the form of noisy sensor observa- tions. Therefore, simply using an activity model is not enough to effectively simulate data for network analytics. Instead, the simulation must be augmented with an observational model for the particular application we wish to study. Once the ob- servable sensor data has been simulated, we can then feed it into the desired network analytics and construct a network. This flow can be seen in Figure 1 where the top half depicts the data synthesis aspect, with parameters describing a pop- ulation's behavior, the activity model generating the popula- tion's actions based on the parameters, and the observational transforming the actions into observable sensor data. The bot- tom half depicts the network analysis problem, with networks being constructed from observed sensor data and then algo- rithms inferring desired properties and parameters of the net- work. This paper is organized as follows: In Section 2. we give a brief background of previous work on simulation models and discuss their advantages and disadvantages. In Section 3. we introduce our activity model that employs the most desirable aspects of statistical and agent-based models. This model uses high-level population parameters to drive an agent-based nar- rative, enabling it to create rich network datasets but also al- lows for generation of numerous, statistically similar datasets for Monte Carlo purposes in analyzing network algorithms. tributions and with block community structures, respectively, properties which are prevalent in many real world popula- tions. These models, however, only specify interactions be- tween nodes and thus fail to encode a narrative of specific actions over time that accurately reflect the constraints and behavior of the target data. The second type of simulation model, agent-based, fixes the lack of narrative by building the network from the ground up. Instantiating individual agents and directly sim- ulating their behavior necessitates that the resulting network obeys the individual constraints imposed on agents' activ- ities. Achieving a high-fidelity narrative comes at a cost, however, as agent-based models struggle with some aspects that come naturally to statistical models. A simulated vehicle motion dataset made available by the National Geospatial- Intelligence Agency (NGA) is a one-off, hand-crafted, agent- based model that simulates over 4000 people driving between over 5000 locations throughout Baghdad, Iraq over a 48-hour time period. Because the network was carefully handcrafted it reflects real world behavior relatively well but it took 2-man years to create and only one instance of it exists, so it cannot be used for Monte Carlo experiments. Agent-based models tend to be very specific in their appli- cation focus and require highly tuned parameters and intri- cate understanding of the application space. [12] introduces a powerful agent-based simulation model which provides the necessary data to successfully study the spread of disease through a city in the context of bioterrorism. The model em- ploys pertinent data sources, such as that from census, school districts, drug purchases, emergency room visits, etc. The at- tention to detail ensures a realistic simulation model but ne- cessitates expert knowledge and copious amounts of target data, thus making it difficult to transfer the model to other desirable applications or even for someone not fully experi- enced with the model to re-parameterize it. 3. ACTIVITY MODEL As mentioned in the Introduction, the development of net- work inference algorithms suffers from a lack of truthed, high-fidelity data. Real data is hard to collect and truthing it often runs into privacy concerns. Simulated data can be generated but popular generation methods lack statistical fi- delity or narrative flow. In this section we introduce a mixed- membership, agent-based model that aims to provide both de- sirable aggregate statistics and realistic agent interactions. Instead of directly simulating nodes and edges our ap- proach to simulating network data recognizes the fact that most network data are created by individuals taking actions over time. This could be users clicking on websites, people sending emails, or vehicles driving to locations. We leverage this insight by directly simulating agents' actions over time. Just simulating agents' actions over time would be difficult Figure 1: Network analytics workflow In Section 4. we further the utility of the activity model by in- troducing the observational model that takes abstract network interactions and transforms them into the simulated output of a real sensor, allowing for realistic experimentation methods. We conclude in Section 5. and discuss future work. 2. BACKGROUND Network data come from two sources: collected real world data and simulated data. Real world data sets are are exactly on what the inferential tasks will be run in deployment and thus can claim the highest fidelity. In practice, however, col- lection of this type of data faces many hurdles. Privacy of personal data can cause both regulatory issues and hinder av- enues of potential research, such as [18] needing to follow experimental oversight regulations on cell phone GPS track- ing. The desired data can take a long time to collect and only result in one data set, which is insufficient for Monte Carlo purposes. For example, [22] required two years to observe a social network of only thirty-four people. Possibly most im- portantly for algorithm development, collecting sufficiently representative and comprehensive data on a large scale is a daunting task. [19] explores the prediction of clustering in protein interactions collected by [8], but that data set "rep- resents only a snapshot of the proteome averaged over all phases of the cell cycle." Simulation models can be a powerful alternative for ob- taining the requisite experimental data and can be broken into two categories. First, statistical models employ high- level statistics to describe the aggregate behavior of a popu- lation. This allows researchers to closely match the simulated population to the desired real world population, but gener- ally leads to network interactions that do not have narrative fidelity. The simplest, such as Erdos-R´eyni or Chung-Lu , are easy to parameterize and can quickly provide many large it- erations but are only able to create populations with homo- geneous behavior. [7] [1] Slightly more complicated mod- els, such as RMAT [10] and Blockmodels [9], address that issue by generating populations with power-law degree dis- Parameters Analysis Synthesis Parameters Activity Model Observational Model Network Construction Algorithms/Analytics both to parameterize and to allow agents to be diverse in their nature. To add richness to the data we introduce the concept of roles, which we define as the agent's intention in executing an action. In this way, prior to selecting an action the agent first decides what role it will adopt and then chooses an action based on that role. The model draws from the widely-used concept of mixed- membership in which data are treated as a mixture of classes. Latent Dirichlet Allocation [3] treats documents as a mix- ture of thematic topics. Optical Character Recognition [2] can be implemented to treat a written character as a mixture of potential digits. Mixed-Membership Stochastic Blockmod- els [9] treat networks as a mixture of community membership. We extend these concepts so that instead of agents taking on only one role throughout the entire simulation they can in- stead have a mixture of intentions at any given time To add further fidelity to the data we enable agents to dy- namically change their mixture of roles over the total time of the simulation. The mixture of roles can easily be made cyclical to reflect diurnal patterns of behavior. 3.1. Mathematical Description The essence of the the activity model can be broken into three parts for each event of choosing an action: drawing the time at which the agent's event occurs, drawing the role the agent adopts during the event, and drawing the action the agent actually executes as a result of the event. The plate model in Figure 2 represents the activity model that will be described in detail in this section. Plate models are convenient methods to depict algorithms with replicated variables. Shaded boxes denote input parameters, circles de- note random variables, arrows denote variable dependencies, and plates denote repeated variables, with the variable in the bottom corner of the plate denoting the number of replica- tions. We let N be the number of agents, R be the number of roles, A be the number of possible actions, T be the number of timespans in which we discretize the total time of the simula- tion (e.g. day, evening, night), and Ei be the number of events for the ith agent The algorithm depicted by the plate model in Figure 2 is written out in Algorithm 1. Choosing the event's time Choosing the times of each agent's events first requires de- ciding how many events will occur for the agent. We draw the number of events Ei ∼ Poisson(µτ), where the input τ is the total time of the simulation and the input µ is the aver- age amount of time before the agent waits to initiate another event. The times of the Ei events are then drawn uniformly over the entire time of the simulation. To lend fidelity to agent behavior we allow their parameter- izations to take on different values in the input T timespans Figure 2: Activity model Algorithm 1: Activity model algorithm Data: User defines τ, µ, X, γ, P, G Result: A list of actions ai for each agent i and the time of each action foreach agent i ∈ {1 : N} do \\(cid:11) denotes element-wise division Hi ∼ Multinomial(G(cid:11) G1(A),P) Ei ∼ Poisson(µτ) for event j ∈ {1 : Ei} do I(t) i j ∼ Uniform(0,τ) πi j ∼ Dirichlet(I(t) i j X) I(z) i j ∼ Multinomial(πi j) I(g) i j ∼ Bernoulli(γ) i j Hi + (1− I(g) Yi j = I(g) ρi j ∼ Dirichlet(I(z) i j Yi j) ai j ∼ Multinomial(ρi j) i j )(¬Hi) end end (e.g. propensity towards work during the day, restaurants in the evening, and home at night). We create the indicator I(t) ij , which specifies during which of the T timespans the jth event for the ith agent occurs. In actual implementation we employ Poisson count-time duality to determine the number and timing of events by hav- ing each agent draw sequential waiting times between actions from ∼ Exponential(µ). This allows us to build action dura- tions into the wait times and ensures a realistic narrative in which an agent's actions cannot overlap. EiN⌧i2{1:N};j2{1:Ei}(R)I(z)ijI(t)ij(T)(A)I(a)ij(A)(R,A)Yij(R,A)Hi(R,T)XP(R)(R,A)G(R)⇡ij⇢ijN=#agents;R=#roles;A=#actions;T=#timespandiscretizations;Ei=#eventsforagentiI(g)ij Choosing the agent's role Once the agent has picked a time for each of its events it then chooses roles for those actions. We wish to avoid in- putting a specific distribution over roles for each agent as this will lead to bias in Monte Carlo experiments. Instead we in- put X, the Dirichlet concentration parameters, which specifies the propensity of the population toward roles at each times- pan. To obtain the actual distribution over roles for an event we draw πi j ∼ Dirichlet(I(t) i j X). The actual role for that action is then drawn as the indicator I(z) i j ∼ Multinomial(πi j,1). Choosing the agent's action Once the agent has drawn a role for its jth event it then must draw an actual action to execute. Each action belongs to one of the roles, as specified by the user input G, and can only be executed by an agent in that role. Again, to avoid bias, instead of inputting the distribution over all actions we will draw the distribution as ρi j ∼ Dirichlet(I(z) i j Yi j). Yi j is the Dirichlet concentration parameters which specify the propen- sity of an agent towards every action given the role of the event. Yi j is constructed in two conceptual parts, whether or not this is a normal event and which are the normal actions. At the beginning of the simulation, every agent must determine which actions it deems normal and which actions are abnor- mal. The number of each type of action the agent deems nor- mal is specified by the user input P. In splitting the actions this way the agent will have a routine over time but still be allowed deviate from the norm. The agent draws its normal actions from Hi ∼ Multinomial(G(cid:11) G1(A),P), where (cid:11) de- notes element-wise division. This multinomial draw is set up to uniformly draw normal actions from all possible actions of each type. To determine whether each event is normal or abnormal the agent draws the indicator I(g) i j ∼ Bernoulli(γ). Then the agent constructs its Dirichlet propensity towards all actions for that event by Yi j = I(g) i j )(¬Hi), where ¬ de- notes negation. From that the agent draws its probability dis- tribution over all actions as ρi j ∼ Dirichlet(I(z) i j Yi j). Finally, the agent draws the actual action executed for that event as the indicator I(a) i j Hi + (1− I(g) i j ∼ Multinomial(ρi j,1). 3.2. Activity Model Results We present two types of results to show the capabilities of the activity model. First we display the actions of an indi- vidual agent under different parameter settings to show the richness of model. Second, we tune the parameters to a target data set to demonstrate the ability to simulate data with spe- cific desired behavior and thus successfully provide sufficient data for network analytic experiments. So far we have discussed the activity model in an application-agnostic manner. To ground the discussion of the results we will place the activity model in the human mo- bility modality, specifically people driving throughout a city. This application and the motivation for network analysis of human mobility will be more fully discussed in Section 4. but for now it suffices to say that agents are people, an action is a person driving from their current location to a destination location, and a role is the person's intention to drive to the destination. For example, a person may assume a work role and decide to drive to their company's building. Richness of parameter settings We show the spectrum of the attainable richness of data with varying parameter settings using a toy human mobil- ity example. We simulate 100 agents taking on three possible roles of Home, Work, and Public, with 25, 5, and 10 locations of each type, respectively. A public location may be a park or sports arena. Figure 3 provides spatio-temporal plots of a sin- gle agent's actions over a 24-hour time period to show the ef- fects of varying parameters on behavior. These plots display the progression of an agent's movements over the duration of the simulation. Time proceeds along the positive x-axis in minutes since midnight. Each integer on the positive y-axis represents a location and the locations are separated verti- cally with dashed lines by category. A solid horizontal line indicates the agent staying at that single location over that span of time. A diagonal line indicates an event occurring in which the agent chooses and then travels to a new location. We create three different parameter settings: deterministic, random, and realistic. Figure 3a depicts parameters that cause an agent to deterministically adopt the three roles over spec- ified time spans and choose to execute specified actions for each role. Figure 3b depicts parameters that cause an agent to randomly choose a role at any given point in time and to then randomly choose an action to execute given that role. Figure 3c depicts parameters in the middle-ground where an agent has a normal lifestyle but still retains the ability to deviate from the norm. Comparison to target dataset Simulated data is only useful if it faithfully reflects the tar- get data. Publicly available real-world network data is diffi- cult to employ in this venue given privacy and security con- cerns so we will compare our model to the NGA dataset. As discussed in Section 2., the dataset is a one-off, hand-crafted, agent-based model that simulates over 4000 people driving throughout Baghdad, Iraq over a 48-hour time period. The model is not perfect at simulating realistic movements within a city but it is close enough for our purposes to show that we can achieve a high fidelity comparison to a specific target. (a) Deterministic parameter settings (b) Random parameter settings (a) NGA Agent (c) Realistic parameter settings Figure 3: Spatio-temporal plots depicting an agent's actions over a 24-hour time period in a toy example. The x-axis is minutes since midnight. The y-axis is divided into three roles, with different y values representing different actions and the marker shape also denoting to which role the action belongs. First we parameterized the activity model to match the NGA data as closely as possible. One strength of our model lies in using relatively few, easy-to-set parameters. We di- rectly matched simplistic parameters such as the number of agents, N, the types of roles, R, the number of locations, A, and the location categories, G. With trivial analysis we were able to determine two input parameters not directly accessi- ble in the target data: How many of each actions type an agent deems normal, P, and agent propensities towards roles, X. After using these parameters to simulate an instance of the data we compared our output to the NGA dataset. In our data agents chose to belong to 0.30 fewer locations of each type on average and visited locations of each type 1.98 fewer times on average. Matching agents' actions so closely to the target allows the simulated data to stand in for the NGA dataset in desired Monte Carlo experiments. The current activity model does not account for community structure in the population so we omit any comparison in that domain, though an expansion of the model to include community membership and affinity towards shared locations is certainly feasible. The simulated agent's individual activity also matched that of the NGA agents as can be seen in the two spatio-temporal plots in Figure 4. Over many simulations the agents produce behavior statistically similar but not identical to the target agents, as is desirable for Monte Carlo experiments. In addition to fidelity, running time is an important consid- eration in simulating data so that Monte Carlo experiments (b) Simulated Agent Figure 4: Spatio-temporal plots comparing a simulated agent's and an NGA agent's actions over a 24-hour time pe- riod. with large numbers of trials are feasible. To simulate NGA data with 4623 agents and 5444 locations over 24 hours on a standard Mac desktop currently takes approximately 25 min- utes on average to draw the actions via the activity model and approximately 35 minutes on average to generate the tracks via the observational model that will be discussed in Section 4.. Both models are parallelizable with either Matlab's Par- allel Toolbox or grid computing so we envision being able to significantly speed up the implementation from its current state. 4. APPLICATION: HUMAN MOBILITY The previous section introduced a generalized agent-based activity model and then applied the model to a human mobil- ity application by tuning the parameters to simulate the NGA data set. That simulated data contains agents' abstract actions but researchers may also want to study the sensor observa- tions resulting from the execution of those actions. Therefore, we introduce an observational model for hu- man mobility applications that generates tracks of vehicle movement within a city. The observational model is flexible enough to create simulations for any place in the world for which open-source map data is available. To demonstrate this flexibility and assess the fidelity of the results, we will tailor parameters of the model to match properties of the NGA data set and then show a comparison of the results. 0200400600800100012001400PublicHomeWorkTime since midnight (m)Action TypeAgent's Deterministic Actions Over Time0200400600800100012001400PublicHomeWorkTime since midnight (m)Action TypeAgent's Random Actions Over Time0200400600800100012001400PublicHomeWorkTime since midnight (m)Action TypeAgent's Realistic Actions Over Time0200400600800100012001400HomeWorkWorshipMarketShopBarberRestaurantCoffeeHouseInternetParkSoccerOtherTime since midnight (m)Action TypeIDA Agent's Actions Over Time0200400600800100012001400HomeWorkWorshipMarketShopBarberRestaurantCoffeeHouseInternetParkSoccerOtherTime since midnight (m)Action TypeSimulated Agent's Actions Over Time 4.1. Motivation Tracking movement from location to location lends it- self naturally to network-related data and many interest- ing inference and prediction applications. For example, in wide-area, aerial surveillance systems, vehicle tracks can be used to forensically reconstruct clandestine terrorist net- works. Greater detection can be achieved using network topology modeling to separate the foreground network em- bedded in a much larger background network [17]. Location data recorded by mobile phones has been used to track the movement of large groups of students on a university cam- pus to learn more about human behavior and social network formation [18]. Location data from mobile phone activity can also be used to measure spatiotemporal changes in population to infer land use and supplement urban planning and zoning regulations [11]. Collecting large-scale, persistent data to study human mo- bility, however, is especially difficult. Aerial surveillance sys- tems are limited by practical issues such as flight endurance limitations and line-of-sight occlusions. Even in the absence of these issues, accurate vehicle tracking is very difficult. Fur- thermore, ground truth is required to assess the accuracy of the observed network, but activity of interest rarely includes ground truth or requires pre-planned instrumentation such as GPS sensors. While cell phones equipped with GPS sensors are ubiquitous, such data is difficult to obtain because of le- gal and privacy concerns. Simulating large-scale, persistent data sets to study human mobility would greatly benefit the development of algorithms for applications where such data is limited. 4.2. Observational Model The observational model is comprised of four parts. First, we adapt the activity model to our human mobility applica- tion by specifying agents, actions, and roles in terms of hu- man mobility. Next, we obtain map data and define the road network on which we will create vehicle tracks. Then we la- bel nodes in the network according to the type of physical lo- cation they represent. The final step is to create vehicle tracks by defining paths between intended locations and modeling sensor observations of that motion. Our observation model can be made arbitrarily complex to replicate specific sensor observability and noise characteris- tics. It is also possible to simulate observational data for any conceivable type of sensor. However, detailed sensor mod- eling is beyond the scope of this paper and we assume that algorithms of interest will work at the track level. That is, the algorithms will work with processed detections associ- ated over time to produce only location and time data for each vehicle. Also, since we are interested in constructing network relationships and not behavioral phenomena, we do not simulate low-level micro-behavior of traffic, such as stop lights, multiple lanes, collision avoidance, and traffic conges- tion. These microscopic traffic phenomena can be studied in depth with simulators such as SUMO (Simulation of Urban Mobility) [13]. Adapting the Activity Model We create an observational model for the modality of hu- man mobility, specifically people driving throughout a city. To adapt the activity model to this application we let agents be people within a city. Then each agent performs the action of driving to a specific type of location dictated by the agent's role at that time. Creating the Road Network We can define a road network for any almost any city of in- terest using open-source mapping data. One source of data is the OpenStreetMap (OSM) wiki [5], which contains publicly- available maps from around the world. We are interested in two OSM data elements: nodes and ways. Nodes are singu- lar geospatial points. They are grouped together into ordered lists called ways that define linear features such as roads or closed polygons representing areas or perimeters. Nodes and ways can also carry attributes, such as residential areas and highway types. We represent the road network with a graph where ver- tices are points along every road. An edge exists between two points if they are adjacent on the same road or if they coincide to indicate an intersection. The graph is stored as a weighted adjacency matrix whose weights correspond to the physical length of the node-to-node road segments. Thus, we also have an encoding of the physical distances between each node. This is illustrated in Figure 5. Figure 5: Illustration of road network representation. Dots are nodes along the road and circles are intersections. A link ex- ists for nodes along a common road and for nodes that are intersections. Distances are labeled between nodes. These re- lationships are stored in a weighted adjacency matrix. Physical Location Assignment Next, we label the nodes in the road network according to the types of physical locations they represent. There are two approaches to this labeling depending on the types of map data that are available. 50010002004006008001000nz = 235520Adjacency Matrix For the first case, node labeling is done directly. This is possible with vectorized data where a one-to-one labeling is made for each node. For example, each node and way in the OSM data format can be attributed to indicate characteristics like businesses or highway types. For the other case, node labeling is done indirectly. Either a vectorized set of points defines a polygonal area encompass- ing multiple nodes, or rasterized data specifies a grid whose individual regions may cover several nodes at once. Labeling can be done by assigning all nodes within a region with the same attributes. Depending on the application, labels may not be available for each type of location we would like to simulate. In this case we can infer node types based on related categories. For example, land usage data is available from the National Land Cover Database (NLCD) published by the U.S. Geological Survey [21]. The NLCD data comes in raster format and enu- merates each pixel with Census Feature Class Codes (CFCC) that describes different levels of urban development as well as housing and commercial zones. Therefore we can label each node in the road network with a CFCC and then map that la- bel to a related location type. For example, in areas of high ur- ban development, we could label nodes as high-density apart- ments or small businesses. Because a CFCC could encapsu- late multiple types of roles we define a probability vector πc for each CFCC, which is a 1 × R-dimensional vector. Then for each node we draw from ∼ Multinomial(πc) to determine which role that node adopts for the simulation. In this way we will end up with neighborhoods of generally similar locations but still maintain diversity. Creating Vehicle Routes After defining the road network and labeling the nodes of interest, we can create the final vehicle tracks. To do this we find a route between any two nodes by traversing the graph of the road network using a pathfinding algorithm. While any number of algorithms can be used we assume that peo- ple always take the shortest path. In this paper we use Dijk- stra's shortest path algorithm [6]. However, (non-optimal) al- gorithms can be easily used instead, such as the breadth-first- search algorithm, A* [15], or for extremely large networks, contraction hierarchies [16]. The output of the pathfinding algorithm is a sequence of nodes. However, to produce a proper track containing vehicle positions over regular time intervals, we need to assume ba- sic vehicle motion parameters and sensor observation param- eters. In terms of vehicle motion, we sample a distribution of expected vehicle speed to assign to each track. In terms of sensor observations, we assume a zero-mean, Gaussian- distributed noise on the vehicle position and that observations are reported at a constant frame rate. The particular frame rate for each track is drawn from a distribution of expected frame rates in case the sensor reports measurements asyn- chronously. 4.3. Results A model is only useful if it simulates data faithful to the target. In this section we show the results of the activity and observation models with parameters set to match the NGA data set as closely as possible and show a comparison of sim- ulated vehicle tracks to those from the NGA data set. The full road network for Baghdad using OSM map data is shown in Figure 6. It is comprised of 14,087 ways, 68,548 nodes, and covers approximately 10km by 10km. Figure 6: Full road network for Baghdad constructed with OSM data on latitude and longitude axes. For comparison purposes, we used the location labels from the NGA data set to label the nodes in our road network. For each node in the NGA data having a location category, we chose the nearest-neighbor node on our road network to have the same location category. To produce our track results, we had to adjust only two parameters of the observation model: the distribution of vehi- cle velocity and the distribution of observation frame rate. To determine these distributions, we generated a histogram for each with 100 bins and normalized to create a proper prob- ability mass function. Then during each phase of creating a track, these two distributions were sampled to determine the respective parameters for that track. Figure 7 shows the distributions of track velocity and track length for our simulation compared to the NGA data after running the entire simulation for all agents. As expected, the velocity distribution matches very closely. An unanticipated result is the similarity of the track length distributions, which are influenced by the similar labeling of the road network lo- cations and the shortest-path assumption of the pathfinding algorithm. Figure 8 shows measurement density heatmaps for the the NGA data and our simulation. As a result of matching the observation frame rate, the overall density of our simulation closely resembles that of NGA. Another notable similarity is that the traffic behavior in our simulation resembles NGA membership concept to actions in terms of roles and allow that to vary over time to create even greater richness. We also wish to further explore the parameterization of the activity model by adapting it to applications other than human mo- bility and be able to use the subsequent sensor output. To do so we will develop an observational model for a differ- ent application such as interactions on social networks such as Facebook which will also demonstrate our models' utility to different types of researchers. REFERENCES [1] W. Aiello, F. Chung, and L. Linyuan. A random graph model for massive graphs. pages 171 -- 180, 2000. [2] C. Bishop. Pattern recognition and machine learning, chapter 9: Mixture Models and EM. Springer, 2006. [3] D. Blei, A. Ng, and M. Jordan. Latent dirichlet allocation. J. Mach. Learn. Res., 3:993 -- 1022, March 2003. [4] W. Cohen. Enron email dataset, 2009. http://www.cs.cmu.edu/ enron/. [5] OpenStreetMap contributors. National land cover database 2006, September 2012. http://www.openstreetmap.org/. [6] T. Cormen, C. Leiserson, R. Rivest, and C. Stein. Introduction to Algorithms (2nd ed.), chapter 24.3: Dijkstra's algorithm. MIT Press and McGraw-Hill, 2001. [7] P. Erdos and A. R´eyni. On random graphs i. Publicationes Mathematicae, 6:290 -- 297, 1959. [8] A. Gavin et al. Proteome survey reveals modularity of the yeast cell machinery. Nature, 440:631 -- 636, 2006. [9] E. Airoldi et al. Mixed membership stochastic blockmodels. J. Mach. Learn. Res., 9:1981 -- 2014, June 2008. [10] J. Leskovec et al. Realistic, mathematically tractable graph generation and evo- In Knowledge Discovery in Databases: lution, using kronecker multiplication. PKDD 2005. [11] J. Toole et al. Inferring land use from mobile phone activity. In Proc. of the ACM SIGKDD Intl. Wkshp. on Urban Computing. [12] K. Carley et al. Biowar: Scalable agent-based model of bioattacks. IEEE Trans- actions on Systems, Man, and Cybernetics, Part A, 36(2):252 -- 265, 2006. [13] M. Behrisch et al. Sumo - simulation of urban mobility: An overview. In SIMUL 2011, 3rd Intl. Conf. on Advances in System Sim., pages 63 -- 68, Barcelona, Spain, October 2011. [14] M. Girvan et al. Community structure in social and biological networks. Proc. Natl. Acad. Sci. USA, 99:7821, 2002. [15] P.E. Hart et al. A formal basis for the heuristic determination of minimum cost paths. volume 4, pages 100 -- 107, July 1968. [16] R. Geisberger et al. Contraction hierarchies: faster and simpler hierarchical rout- ing in road networks. In Proc. of the 7th Intl. Conf. on Experimental Algorithms. [17] S. Smith et al. Network discovery using wide-area surveillance data. In Informa- tion Fusion, 2011 Proc. of the 14th Intl. Conf. on, pages 1 -- 8, july 2011. [18] W. Dong et al. Modeling the co-evolution of behaviors and social relationships us- ing mobile phone data. In Proc. of the 10th Intnl. Conf. on Mobile and Ubiquitous Multimedia, pages 134 -- 143, 2011. [19] Z. Xie et al. Proteome survey reveals modularity of the yeast cell machinery. Bioinformatics, 27:159 -- 166, 2011. [20] B. Junker and F. Schreiber. Analysis of biological networks, 2008. Wiley- Interscience. [21] U.S. Geological Survey. National land cover database 2006 (nlcd2006), June 2012. http://www.mrlc.gov/nlcd06 data.php. [22] W. Zachary. An information flow model for conflict and fission in small groups. J. of Anthropological Res., 33:452 -- 473, 1977. Figure 7: Comparison of NGA and simulated tracks: (a) ve- locity distribution and (b) track length distribution. data very well. Major highways have the heaviest traffic while secondary roads are proportionately less dense. Figure 8: Comparison of NGA and simulation observation density heatmaps. Density level is on logarithmic scale. 5. CONCLUSION This paper presents a novel, mixed-membership, agent- based simulation model to generate network activity data for a broad range of research applications. The model com- bines the best of real world data, statistical simulation mod- els, and agent-based simulation models by being easy to im- plement, having narrative power, and providing statistical di- versity through random draws. We apply this framework to study human mobility and demonstrate the model's utility in generating high fidelity traffic data for network analytics. We also adapted the model to a high-fidelity NGA data set and showed that the model can replicate its important properties. While we were able to closely match the average agent activity to the target NGA dataset it is clear that the activ- ity model as is may not be rich enough to satisfy all re- search needs. Agents' propensity towards locations is cur- rently defined on the population level so there is no direct sense of community, an important aspect of many network analyses. To extend the model, we will introduce the con- cept of lifestyles which will group agents together by simi- lar affinities to locations. Additionally, locations in the NGA dataset are of only one type each but we foresee the power of allowing an activity to be executed while an agent is in various different roles. To do so we will apply the mixed- 4681000.020.040.060.08IDA Velocity DistributionVelocity (m/s)Probability4681000.020.040.060.08Simulation Velocity DistributionVelocity (m/s)Probability05101500.010.02IDA Track Length DistributionLength (km)Probability05101500.010.02Simulation Track Length DistributionLength (km)ProbabilityIDA ObservationDensitySim ObservationDensity
1802.06946
3
1802
2018-12-13T01:22:17
Coupon Advertising in Online Social Systems: Algorithms and Sampling Techniques
[ "cs.SI" ]
Online social systems have become important platforms for viral marketing where the advertising of products is carried out with the communication of users. After adopting the product, the seed buyers may spread the information to their friends via online messages e.g. posts and tweets. In another issue, electronic coupon system is one of the relevant promotion vehicles that help manufacturers and retailers attract more potential customers. By offering coupons to seed buyers, there is a chance to convince the influential users who are, however, at first not very interested in the product. In this paper, we propose a coupon based online influence model and consider the problem that how to maximize the profit by selecting appropriate seed buyers. The considered problem herein is markedly different from other influence related problems as its objective function is not monotone. We provide an algorithmic analysis and give several algorithms designed with different sampling techniques. In particular, we propose the RA-T and RA-S algorithms which are not only provably effective but also scalable on large datasets. The proposed theoretical results are evaluated by extensive experiments done on large-scale real-world social networks. The analysis of this paper also provides an algorithmic framework for non-monotone submodular maximization problems in social networks.
cs.SI
cs
JOURNAL OF LATEX CLASS FILES, VOL. 14, NO. 8, AUGUST 2015 i Coupon Advertising in Online Social Systems: Algorithms and Sampling Techniques Guangmo (Amo) Tong, Student Member, IEEE, Weili Wu, Member, IEEE, and Ding-Zhu Du Abstract -- Online social systems have become important platforms for viral marketing where the advertising of products is carried out with the communication of users. After adopting the product, the seed buyers may spread the information to their friends via online messages e.g. posts and tweets. In another issue, electronic coupon system is one of the relevant promotion vehicles that help manufacturers and retailers attract more potential customers. By offering coupons to seed buyers, there is a chance to convince the influential users who are, however, at first not very interested in the product. In this paper, we propose a coupon based online influence model and consider the problem that how to maximize the profit by selecting appropriate seed buyers. The considered problem herein is markedly different from other influence related problems as its objective function is not monotone. We provide an algorithmic analysis and give several algorithms designed with different sampling techniques. In particular, we propose the RA-T and RA-S algorithms which are not only provably effective but also scalable on large datasets. The proposed theoretical results are evaluated by extensive experiments done on large-scale real-world social networks. The analysis of this paper also provides an algorithmic framework for non-monotone submodular maximization problems in social networks. Index Terms -- Social networks, social advertising, approximation algorithm. ! 1 INTRODUCTION O Nline social networks have become important plat- forms for viral marketing as they allow fast spread of brand-awareness information. As a typical diffusion pro- cess, the influence starts to spread from seed users and then goes round by round from active users to inactive users. The classic influence maximization (IM) problem aims to find the seed users that can maximize the number of influenced nodes. In the seminal work [1], Kempe et al. propose the triggering model and formulate the IM problem as a combinatorial optimization problem. A set function h() over a ground set N is submodular if h(N1 ∪ {v}) − h(N1) ≥ h(N2 ∪ {v}) − h(N2) (1) for any N1 ⊆ N2 ⊆ N and v ∈ N \ N2. It turns out that IM is a size-constraint monotone submodular maximization problem and therefore the natural greedy algorithm yields a good approximation [2]. In the past decade, a huge body of works has been devoted to influence related problems such as rumor blocking, active friending and effector detection, just to name a few. The process of influence diffusion generalizes the spread of many kinds of information such as news, ideas and advertisements. In this paper, we crystallize the influence diffusion process and in particular consider the advertising of product in online social systems. Influenced node Vs. Adopter. Whereas IM is motivated by viral marketing, maximizing the influence may not result in a high profit because an influenced node is not necessarily to be an adopter of the product. As mentioned in Kalish's work [3], the adoption of a new product is characterized • G. Tong, W. Wu, and D.-Z. Du are with the Department of Computer Science Erik Jonsson School of Engineering and Computer Science The University of Texas at Dallas, 800 W. Campbell Road; MS EC31 Richard- son, TX 75080 U.S.A. E-mail: [email protected] by two steps: awareness and adoption. The traditional in- fluence diffusion models characterize the spread of brand- awareness information but they do not take account of the issue of product adoption. Among the factors that affect the customers' behavior, the price is undoubtedly the most relevant one. In this paper, we consider a simplified adop- tion process by assuming that, once being aware of the product, a customer becomes an adopter if they believe the product is fairly priced, and only an adopter can bring more adopters by passing on the product information further to their friends1. Coupon Systems. A real advertising campaign is often conducted with promotional tools such as coupon, reward, free sample and etc. Coupon has been demonstrated to be an effective promotional method as it creates short- term excitement [4] and therefore immediately impacts the customers' purchase behavior. Hence, in online social mar- keting, coupon enables the seller to convince the influential users who were not able to be adopters without a coupon. In this paper, we consider the marketing process where the seed buyers are offered with coupons. From the perspective of sellers, coupons are not free because they essentially lower the price of the product. Therefore, increasing the number of seed buyers does not necessarily bring more profit, which leads the non-monotonicity of the objective function of the considered problem. This paper. By integrating coupon system into the general triggering model [1], we in this paper propose the triggering-coupon (T-C) model for product advertising process with coupon in social networks. Based on the T-C model, we consider the problem of selecting seed buyers such that the profit can be maximized, which is termed as 1. The analysis in paper can be applied to other models where the adoption process is independent from the influence process. JOURNAL OF LATEX CLASS FILES, VOL. 14, NO. 8, AUGUST 2015 profit maximization (PM) problem. As discussed later, the difficulty in solving the PM problem lies in two aspects. First, as a function of the seed users, the profit under the T-C model is submodular but not monotone increasing anymore. Consequently, the well-known greedy algorithm does not work and we have to look for other approximation algorithms2 for unconstrained submodular maximization (USM). With the very recent research progress, USM admits several approximation algorithms where the state-of-the-art one achieves the approximation ratio of 1 2 [5]. However, even with such algorithms, the PM problem remains hard to solve because the function value cannot be efficiently computed. The existing USM algorithms assume that there is an oracle of the objective function while, unfortunately, computing the profit under the T-C model is a #P-hard problem. Since the exact value of the objective function is hard to compute, one naturally seeks help from its estimates obtained by sampling. With different sampling techniques, we design several algorithms for the PM problem. The most straightforward approach to applying the existing algorithms is to obtain the function value by sampling whenever its oracle is called, which we call the forward sam- pling framework. Under this approach, the estimates can be obtained by either directly simulating the diffusion process or generating realizations3 according to the definition of triggering model. With such two methods, we give the simulation-based profit maximization (SPM) algorithm and the realization-based profit maximization (RPM) algorithm. Motivated by the study of IM problem, we further design two algorithms, RA-T algorithm and RA-S algorithm, based on the reverse sampling technique. The reverse sampling is initially proposed by Borgs et al. [6] for IM problem and it is later improved by Tang el al. [7] and Nguyen et al. [8]. In this paper, we show how the reverse sampling can be used to solve the PM algorithm. All the algorithms proposed in this paper achieve the approximation ratio of 2 −  with a high probability. Different from most of the 1 existing works, this paper gives an analysis framework for non-monotone submodular problems in social networks. Extensive experiments have been performed for testing the proposed approaches. In the experiments, besides showing the effectiveness and efficiency of our algorithms, we also provide several interesting observations. Organization. The rest of this paper is organized as fol- lows. Sec. 2 reviews the related works. The preliminaries are provided in Sec. 3. The analysis of the algorithms designed based on forward sampling and reverse sampling is shown in Secs. 4 and 5, respectively. In Sec. 6, we present the experiments together with the discussion of the results. Sec. 7 concludes this paper. 2 RELATED WORK Influence Maximization. Domingos et al. [9] are among the first who study the value of customers in a social network. Kempe et al. [1] propose the IM problem and build the triggering model for influence diffusion. As two concrete 2. The PM problem is NP-hard and therefore approximation algo- rithms are the best possible solutions with performance guarantees. 3. As introduced later in Sec. 4.2, the so-called realization is a deran- domization of a triggering model. ii triggering models, independent cascade (IC) model and linear threshold (LT) model have been widely adopted in literature. For the IM problem, Kempe et al. [1] give a greedy algorithm running with Monte Carlo simulations. Leskovec et al. [10] later improve the greedy algorithm with the method of lazy-forward evaluation. However, Monte Carlo simulation is very time-consuming and therefore those two algorithms are not scalable to large datasets. Borgs et al. [6] invent the reserve sampling technique which essentially provides a better way to estimate the function value. With the reverse sampling technique, Tang et al. ( [11] and [7]) design two efficient algorithms which are improved later by Nguyen et al. [8]. Very recently, Arora et al. [12] ex- perimentally evaluate the existing algorithms for IM and make a comprehensive comparison. Besides approximation algorithms, efficient heuristics are also developed for large graphs, namely Chen et al. [13] and Cheng et al. [14]. Profit Maximization. Since the investigation of IM, many influence related problems in social networks have been studied. In what follows, we briefly review the works that are related to profit maximization. One branch of the ex- isting works focuses on pricing issue of the product, and they either formulate the price setting as a game, such as Arthur et al. [15], Zhou et al. [16] and Lu et al. [17], or study the optimal price setting such as Zhu et al. [18]. Yang et al. [19] consider the problem of finding the optimal discount such that the adoption of the product can be maximized. While also aims to maximize the profit, our paper considers the problem of selecting appropriate seed users instead of designing price strategies. As the most relevant works, Lu et al. [20] and Tang et al. [21] also consider the problem of maximizing profit by selecting high quality seed users. In particular, Lu et al. in [20] design a heuristic and Tang et al. in [21] provide an algorithmic analysis with the utilization of the techniques of USM. Whereas the algorithms proposed in [21] have a strong flavor of approximation bound, they are time consuming as they use Monte Carlo simulations. In this paper, our goal is to design profit maximization algorithms that are not only provably effective but also highly scalable. 3 PRELIMINARIES This section provides the preliminaries to the rest of this paper. 3.1 System Model In this subsection, we give a formal description of the considered model. Influence Model. The structure of a social network is given by a directed graph G = (V, E) where V = {v1, ..., vn} denotes the set of users and E is edge set. Let n and m be the number of users and edges, receptively. If there is an edge (u, v) in E, we say u (resp. v) is an in-neighbor (resp. an out-neighbor) of v (resp. u). Let N + v be the set of the out-neighbors and in-neighbors of v, respectively. From the view of influence diffusion, we say a user is active if they successfully receive the target information from their neighbors. Depending on the ways of influence diffusion, many influence models has been developed. In this paper, we consider the general triggering model of which the famous IC and LT models are special cases. v and N− JOURNAL OF LATEX CLASS FILES, VOL. 14, NO. 8, AUGUST 2015 Definition 1 (Triggering Model [1]). An influence model is a triggering model if its diffusion process can be equivalently described as follows. Each node v independently chooses a random "triggering set" Tv according to some distribution over subsets of its in-neighbors. To start the process, we target a set of users for initial activation. After the initial iteration, an inactive node v become active at time step t if it has an in-neighbor in its chosen triggering set Tv that is active at time step t − 1. By Def. 1, a triggering model is given by a pair (G,D) where G = (V = {v1, ..., vn}, E) is the network structure and D = {Dv1, ...,Dvn} is a set of distributions. In partic- ular, Dvi specifies the distribution over subsets of the in- neighbors of user vi. As two special triggering models, IC model and LT model are defined as follows. Definition 2 (IC model.). The IC model assumes that an active user has one chance to activate each of their neighbors with a certain probability and the activations of different pairs of users are independent. Under this model, each edge (u, v) is assigned a real number p(u,v) ∈ (0, 1] which is the propagation probability from u to v. Under the IC model, the distribution Dvi is given by the probability of the edges. For a node v, an in-neighbor u of v has the probability p(u,v) to appear in the triggering set Tv. Definition 3 (LT model.). Under the general threshold model, a user becomes active if they have received sufficient influence from their neighbors. Specifically, each edge (u, v) has a weight w(u,v) > 0 and each user v holds a threshold u∈A(v) w(u,v) ≥ θv where A(v) is the set of active in-neighbors of user v. For the linear threshold model, we further require that, for each w(u,v) ≤ 1 and the threshold θv is selected uniformly at random from [0, 1]. As shown in [1], taking LT model as a triggering model, the triggering set Tv of a node v is decided as follows: v selects at most one of its in-neighbors at random where an in-neighbor u has the probability of w(u,v) to be selected and with probability θv > 0. The user v becomes active if(cid:80) user v,(cid:80) u∈N − v u∈N − v w(u,v) that v does not pick any edges. 1 −(cid:80) Note that the diffusion process under triggering model is stochastic as the triggering sets are generated at random. An important property of triggering model is shown as follows. Theorem 1 ( [1]). Under a triggering model, the expected number of active nodes is a submodular function with respect to the seed set. For most of the triggering models, the process defined in Def. 1 is not the real diffusion process. For example, instead of the generating the triggering sets in advance, the real diffusion process of IC model goes round by round from inactive users to active users until no user can be further activated. Coupon System. In this paper, we consider the very basic coupon system where a product is associated with two features, P and C, which, respectively, denote the price of the product and the value of the coupon. Let Iv be the intrinsic value4 held by v for the considered product. After 4. The intrinsic value is also referred as costumer evaluation in other literatures. Obtaining the real intrinsic value of a certain customer is out of the scope of this paper and we assume it is given in prior. iii receiving the information of the product, a user becomes an adopter if they believe the product is fairly priced, i.e., Iv ≥ P . Without coupons, only the users with Iv ≥ P can be considered as seed users, while once given a coupon the user v with Iv ≥ P − C can also be the seed adopters. In equivalent, one may say the intrinsic value of user v increases to Iv +C if a coupon is offered. In a social network, there can be some influential users whose intrinsic value is less than the price of the product, but coupon allows the seller to activate such powerful users and consequently raises the total profit. We denote by r = P−C the ratio of the price P to P − C. One can take r as a normalized discount ratio of the product. T-C Model. Combining the influence model with coupon system, we have the triggering-coupon (T-C) model of which the marketing process unfolds as follows. P • Initially all the nodes are inactive and a seed set S ⊆ V is decided. • At each time step t, an inactive node v become active if (a) v is activated by its neighbors and (b) Iv ≥ P . • The process terminates when there is no user can be further activated. Under the T-C model, the active users correspond to the adopters of the product. To distinguish it from the pure influence model, we will use adopter instead of active user in the rest of this paper. With the coupon system, the diffusion process is slightly different from the traditional spread of influence. However, the T-C model itself forms a new triggering model. Lemma 1. A triggering model combined with the coupon system yields a new triggering model. Proof. Let D = {Dv1, ...,Dvn} be the set of the distributions given by the triggering model. With the coupon system, the T-C model can be taken as another triggering model where the new triggering distribution D(cid:48) v of each node v is defined as D(cid:48) v = if Iv ≥ P empty distribution otherwise. (cid:40)Dv (2) where the empty distribution always returns the empty set. That is, for a node v, if Iv ≥ P then the distribution remains unchanged and Tv is decided according to Dv, otherwise, Tv is always the empty set as v can never be an adopter. An instance of the T-C model is called a T-C network. A T-C network Υ consists of a graph topology, the price of the product, the value of the coupon, and a distribution of triggering set for each node defined in Eq. (2). In this paper, we use the general T-C model for analysis, and adopt the IC-coupon (IC-C) and LT-coupon (LT-C) models for experiments. 3.2 Problem Definition Given a set S of seed users and a T-C network Υ, let π(S) be the expected number of adopters under S. For a user v, if P > Iv +C, then v cannot be an adopter even if offered with a coupon. Without loss of generality, we can remove such nodes from the network in advance and therefore assume (cid:48) JOURNAL OF LATEX CLASS FILES, VOL. 14, NO. 8, AUGUST 2015 Algorithm 1 Buchbinder's Algorithm 1: Input: h(),N = {v1, ..., vn}; 2: X0 ← ∅, Y0 ← N ; 3: for i = 1 : n do 4: 5: 6: 7: ai ← h(Xi−1 ∪ {vi}) − h(Xi−1); bi ← h(Yi−1 \ {vi}) − h(Yi−1); i ← max{ai, 0}; b i ← max{bi, 0}; (cid:48) a rand ← a random number from 0 to 1 generated in if rand ≤ a Xi ← Xi−1 ∪ {vi}, Yi ← Yi−1. Xi ← Xi−1, Yi ← Yi−1 \ {vi}; 8: 9: 10: 11: 12: Return Xn; that P ≤ Iu + C holds for every user u ∈ V . For a seed set S, the earned profit is P · π(S) minus the cost of the offered coupons. Let (cid:48) i = 0 then uniform; else (cid:48) (cid:48) i/(a i + b (cid:48) i) or a (cid:48) i + b f (S) = P · π(S) − C · S (3) be the profit under S. In this paper, we aim to find a seed set S such that the profit can be maximized, which is termed as the Profit Maximization (PM) problem. Problem 1 (Profit Maximization). Given a T-C network Υ, find a set S of seed adopters such that f (S) can be maximized. Let Vopt ⊆ V be the optimal solution. Note that f (Vopt) ≥ f (V ) and therefore f (V ) = (P − C) · n (4) is a lower bound of the optimal profit. The following lemma gives the key property of our objective function. Lemma 2. f (S) is submodular but not always monotone increas- ing. Proof. Since S is linear, it suffices to show π() is submod- ular. By Lemma 1, the T-C model is a triggering model and therefore π() is submodular due to Theorem 1. Consider a simple instance of IC-C model where V = {v1, v2}, E = {(v1, v2)} and p(v1,v2) = 1. Suppose that P ≥ Iv2. In this example, f ({v1}) = 2P − C while f ({v1, v2}) = 2P − 2C. Therefore, f () may not be monotone increasing, which inevitably incurs more difficulty in designing good algorithms. 3.3 Unconstrained Submodular Maximization With the recent works, several approximation algorithms are now available for non-monotone submodular maxi- mization. In particular, Feige et al. [22] propose a deter- ministic local-search 1 3 -approximation and a randomized 2 5 -approximation algorithm for maximizing nonnegative submodular functions. The state-of-the-art algorithm [5] achieves a 1 2 -approximation proposed by Buchbinder et al., as shown in Alg. 1. iv Lemma 3 ( [5]). Given an objective function h() over a ground set N , the set produced by Alg. 1 is a 1 2 -approximation5 provided that h() is submodular and h(∅) + h(N ) ≥ 0.6 The existing algorithms assume the availability of an oracle of the objective function. However, it turns out that computing the exact value of π(S) is #P-hard [13]. As seen in the recent works on influence related problems, the main difficulty in solving such problems has shifted from approximation algorithm design to the estimating of the expected influence π(S). Since the value of f () is hard to compute, Alg. 1 cannot be directly applied. Given that the diffusion process is stochastic, for a certain seed set S, f (S) can be naturally estimated by sampling. In this paper, we discuss several sampling methods and show how they can be integrated into the existing approximation algorithms. In particular, we use the Buchbinder's algorithm (Alg. 1) for illustration. For a small value  ∈ (0, 1 2 ) and a large value 2 − , 1 − 1 N > 0, an algorithm is a ( 1 N )-approximation if it is able to produce a solution with an approximation ratio of 2 −  with least 1 − 1/N probability 7. We aim to design the 1 algorithms with such a performance guarantee and assume that  and N are fixed in the rest of this paper. Sampling methods can be generally classified into two categories, forward sampling and reverse sampling. As the name suggests, the forward sampling methods obtain an estimate of π(S) by directly running the diffusion process while the reverse sampling methods simulate the diffusion process in the reverse direction. The algorithms designed based on such sampling techniques are shown in next two sections. 4 FORWARD SAMPLING Before discussing the PM problem, let us first consider the general submodular maximization problem in the case that the exact function value is hard to compute. For Alg. 1, suppose that an estimate h() of h() is employed whenever h() is called. One can expect that the approximation ratio can be arbitrarily close to 1 2 as long as the estimates are sufficiently accurate. The modified algorithm is shown in Alg. 2, which slightly differs from Alg. 1 and takes a lower bound L∗ of the optimal value as an extra input. The following key theory indicates the relationship between the precision of the estimates and the approximation ratio. Theorem 2. For any instance (h(),N = {v1, ..., vn}) and any  ∈ (0, 1 2 − )-approximation, if 2 ), Alg. 2 is a ( 1 h(S) − h(S) ≤  n · L∗ (5) holds for each S inspected by Alg. 2 where h(S) is the estimate of h(S) and L∗ is a lower bound of the optimal value of h(). Proof. See Appendix B.1. 5. Strictly speaking, Alg. 1 provides an expected 1 2 -approximation as it is a randomized algorithm. For simplicity, we will take such a solution as an exact 1 2 -approximation. This does not affect the fundamental issues of our analysis. 6. In [5], it is assumed that h() is non-negative while in fact we only need that h(∅) + h(N ) ≥ 0. The proof is similar to that of Theorem 2 shown later. A detailed discussion is provided by J. Tang el al. [21]. 7. 1 2 is the best possible ratio for general unconstrained submodular maximization [22]. JOURNAL OF LATEX CLASS FILES, VOL. 14, NO. 8, AUGUST 2015 Algorithm 2 Forward Sampling Framework 1: Input: (h(),N = {v1, ..., vn}, , L∗); 2: X0 ← ∅, Y0 ← N ; 3: for i = 1 : n do 4: 5: 6: 7: ai ← h(Xi−1 ∪ {vi}) − h(Xi−1) + 2 bi ← h(Yi−1 \ {vi}) − h(Yi−1) + 2 i ← max{ai, 0}; b i ← max{bi, 0}; (cid:48) a rand ← a random number from 0 to 1 generated in if rand ≤ a n · L∗; n · L∗; (cid:48) (cid:48) (cid:48) i + b i) or a i/(a (cid:48) (cid:48) i + b i = 0 then uniform; (cid:48) 8: 9: 10: 11: 12: Return Xn; else Xi ← Xi−1 ∪ {vi}, Yi ← Yi−1. Xi ← Xi−1, Yi ← Yi−1 \ {vi}; Alg. 2 provides a framework for maximizing a submod- ular function h() when the exact value of h() is hard to compute and an accurate estimator h() is obtainable. In the rest of this section, we introduce two estimators of π() and apply the above framework to solve the PM problem. 4.1 SPM Algorithm A straightforward way to estimate π(S) is to use Monte Carlo simulation. That is, for a given seed set S, we simulate the diffusion process under the considered T-C model to obtain the samples of π(S) and take the sample mean as the estimator. For a seed set S ⊆ V , let (cid:101)πl(S) be the and define that (cid:101)fl(S) = P · (cid:101)πl(S) − C · S. By taking sample mean obtained by running l times of simulations f (V ) as the lower bound of f (Vopt), the Alg. 2 with input ( fl(), V, , f (V )) is able to produce a good approximation to the PM problem provided that Eq. (5) is satisfied for each estimating. We denote by this approach as the simulation- based profit maximization (SPM) algorithm. For each estimating, the difference between (cid:101)πl(S) and π(S) can be bounded by Chernoff bound as the simulations are executed independently. A useful form of Chernoff bound is provided in Appendix A and we will use Eqs. (17) and (18) throughout this paper. The following lemma shows the number of simulations needed to meet the accuracy required by Eq. (5). Lemma 4. For a certain set S ⊆ V and 1 2 >  > 0, we have Pr[(cid:101)fl(S) − f (S) >  n f (V )] ≤ 1 4nN , if l ≥ δ0 where (6) (7) (ln 8 + ln n + ln N )(2n2 + rn) . δ0 = 2r2 bound. By rearrangement, Pr[(cid:101)fl(S) − f (S) >  equal to Pr[l · (cid:101)πl(S) n · (P−C) Chernoff bound, this probability is no larger than Proof. It can be proved by directly applying the Chernoff n · f (V )] is P·π(S) ]. Applying n > l · π(S) n − l · π(S) 2 exp(− l · π(S) n · ( (P−C) P·π(S) )2 2 + ( (P−C) P·π(S) ) ) . By Eq. (7) and π(S) ≤ n, this probability is at most 1 4nN . v ; 2r2 triggering sets for each node; Algorithm 3 Realization-based Profit Maximization 1: Input: Υ,  and N; 2: l ← (ln 8+ln n+ln N )(2n2+rn) 3: Generate l realizations Gl = {g1, ..., gl} by sampling 4: V ∗ ← Forward Sampling Framework((cid:98)fGl (), V, , f (V )); 2 ) and N > 0, to achieve a ( 5: Return V ∗; Theorem 3. For any  ∈ (0, 1 − )-approximation with probability at least 1 − 1/N, the SPM algorithm demands the running time of O(mn3 ln n). 4 and the union bound, (cid:101)fl(S)−f (S) ≤  Proof. Since there are 4n sets inspected by Alg. 2, by Lemma n f (V ) holds for ev- ery inspected set with probability at least 1 − 1/N provided that l ≥ δ0. Therefore, by Theorem 2, the approximation −  if l = δ0. Because δ0 simulations are used for ratio is each estimating and there are totally 4n estimated function values, the number of executed simulations is 4δ0n. The total running time is therefore O(4δ0nm) as one simulation costs O(m) in the worst case. 1 2 1 2 Note that executing one simulation for f (S) costs O(m) in the worst case but in fact it is proportional to f (S) which is usually much smaller than m. 4.2 RPM Algorithm Now let us consider another estimator of f (). As mentioned in Sec. 3, the real diffusion process of a triggering model, namely IC and LT model, is equivalent to the one described in Def. 1. Therefore, instead of simulating the real diffusion process, one can obtain an estimate of π(S) by sampling the triggering set of each node. When the triggering set of each node is determined, we obtain a realization of the given network. Definition 4 (Realization). For a T-C network Υ, a realiza- tion g = {T1, ..., Tn} is a collections of triggering sets of the nodes where Tv is sampled according to distribution given by Υ. Equivalently, a realization can be taken as a deterministic T-C network. The following lemma directly follows from the definition of triggering model. Lemma 5. Given a seed set S, the following two processes are equivalent to each other with respect to π(S). • Process a. Execute the real diffusion process on G. • Process b. Randomly generate a realization g and execute the diffusion process on g according to Def. 1. under S on realization g and correspondingly we define For a seed set S, let (cid:98)πg(S) be the number of adopters that (cid:98)f (g, S) = P · (cid:98)πg(S) − C · S. According Lemma 5, in Lemma 5 and calculating the mean of(cid:98)πg(S). Given a set one can estimate π(S) by repeatedly executing the Process b of l realizations Gl = {g1, ..., gl} generated independently, for a seed set S, let(cid:98)πGl (S) = (cid:80)l i=1(cid:98)πgi (S) (8) l JOURNAL OF LATEX CLASS FILES, VOL. 14, NO. 8, AUGUST 2015 Algorithm 4 RA Set 1: Input: Υ; 2: Select a node v from V uniformly in random; 3: Sample a realization g of Υ; 4: Return the nodes that are reverse-adopted-reachable to v in g; and (cid:98)fGl (S) = (cid:80)l i=1 (cid:98)f (gi, S) = P ·(cid:98)πGl (S) − C · S. (9) l Now we have another estimator (cid:98)fGl () that can be utilized in the framework of Alg. 2. The obtained algorithm is shown in Alg. 3 which is named as realization-based profit maximization (RPM) algorithm. According to Lemma 2, in order to obtain a good approximation one should generate sufficient number of realizations such that Eq. (5) can be satisfied. In fact, the number of total realizations required herein is the same as that of the simulations required in the SPM algorithm, shown as follows. Lemma 6. Suppose l realizations are generated for estimating. For any  ∈ (0, 1 2 ) and N > 0, with probability at least 1 − 1 N , n f (V ) holds for every S inspected by Alg .2, (cid:98)fGl (S)− f (S) ≤  if l is not less than δ0 defined in Eq. (7). Proof. The proof is same as that of Lemma 4. According to Def. 1, generating one realization costs O(m) time. For a certain realization g and a seed set S, computing (cid:98)f(g, S) can be done in O(n + m) time by the breadth-first search, and therefore (cid:98)fGl (S) can be computed in O(l(m+n)). Hence, Alg. 1 totally costs O(lm+ln(m+n)). Setting l to be δ0 gives the running time of O(mn3 ln n). Theorem 4. For any  ∈ (0, 1 2 ) and N > 0, the RPM algorithm − )-approximation with a probability at least 1 − provides a ( 1/N with the running time of O(mn3 ln n) with respect to m and n. 1 2 One can see that the running times of SPM algorithm and RPM algorithm are in the same order with respect to m and n. However, the actual number of operations executed by SPM algorithm is about 4lmn while the RPM algo- rithm roughly conducts lmn operations. Therefore, when the graph is large, the SPM algorithm is likely to be more efficient. For practical implementation, because one realiza- tion g can be used to estimate f (S) for any seed set S, we can generate the realizations in advance and use them later in real-time computation, which is another advantage of the RPM algorithm. 5 REVERSE SAMPLING In this section, we present two algorithms which are able 2 −  but require to provide the approximation ratio of 1 significantly less running time than RPM and SPM do. Such algorithms are designed based on the technique of reverse sampling which is firstly invented by Borgs. et al. [6] for the IM problem. In the reserve sampling framework, the key object is the reverse adopted-reachable set. vi Definition 5. For a node v and a realization g = {T1, ..., Tn} of a T-C network Υ, a node v∗ is reverse-adopted-reachable to v in g if there is a sequence of nodes u1, ..., uk such that u1 = v, uk = v∗ and vi+1 ∈ Tvi for 1 ≤ i ≤ k − 1. Definition 6. (Reverse Adopted-reachable (RA) Set8) For a T- C network Υ, an RA set is a set of nodes randomly generated by Alg. 4. As shown therein, we first select a node v in V uniformly in random and then sample a realization g of Υ. Finally, it returns the nodes that are reverse-adopted- reachable of v in g. For a seed set S ⊆ V and a RA set R, let x(R, S) be a variable such that (cid:40) 1 if R ∩ S (cid:54)= ∅ 0 otherwise. x(S, R) = Since R is generated randomly, x(S, R) is a random vari- able. The following lemma shows that n · x(S, R) is a unbiased estimate of π(S). Lemma 7. For any seed set S, E[x(S, R)] = π(S) n . Proof. See Appendix B.2 Let Rl = {R1, .., Rl} be a set of l RA sets independently generated by Alg. 4 and let F (Rl, S) = P · n · (cid:80)l i=1 x(Ri, S) − C · S. l The following problem plays an important role in solv- ing the PM problem. Problem 2 (Cost Set Cover Problem). Given a collection Rl of RA sets, find a set S such that F (Rl, S) is maximized. Lemma 8. Given Rl, F (Rl, S) is a submodular function with respect to S. Proof. The first part of F (Rl, S) is exactly the set cover problem and its second part is linear to S. is submodular Since F (Rl, S) and F (Rl,∅) + F (Rl, V ) = 0+(P −C)·n ≥ 0, by Lemma 3, Alg. 1 provides an 1 2 -approximation to Problem 2. By Lemma 7, F (Rl, S) is an unbiased estimate of f (S). Hence, the set S that can maximize F (Rl, S) can intuitively be a good solution to the PM problem, which is the main idea to solve the PM problem by the reverse sampling. 5.1 RA-T Algorithm In this section, we present the first algorithm designed with the reverse sampling, as shown in Alg. 5. In this algorithm, we first decide a threshold l, generate l RA sets, and then run Alg. 1 to solve Problem 2. We term this algorithm as the RA-T algorithm where RA-T stands for reverse adopted- reachable (RA) set with a threshold (T). As shown in the following, for any  ∈ (0, 1 2 ), the RA-T algorithm produces 2 − )-approximation to the PM problem with a high a ( 1 probability, as long as l is sufficiently large. 8. The RA set defined in this paper is analogous to the hyperedge in [6], the reverse reachable set in [7] and the random R-tuple in [23]. JOURNAL OF LATEX CLASS FILES, VOL. 14, NO. 8, AUGUST 2015 Algorithm 5 RA-T Algorithm 1: Input: Υ,  and N; 2: δ1 ← (ln N + n ln 2)(2 + 1r) 3: δ2 ← 2 ln N 2r2 ; 2 4: l = max(δ1, δ2); 5: Independently generate a collection Rl = {R1, ..., Rl} 6: V ∗ ← Buchbinder's Algorithm (F (Rl, S), V ); 7: Return V ∗; of l RR sets by Alg. 4; 2 1r2 ; Let 1 > 0 and 2 > 0 be some adjustable parameters 1 + 1 2 2 = . δ1 = (ln N + n ln 2)(2 + 1r) 2 1r2 , (10) (11) where Set that and 2 ln N 2r2 , 2 δ2 = (12) Lemma 9. Given a set Rl of l RA sets generated independently by Alg. 4, with probability at most 1/N, there exists some S ⊆ V such that F (Rl, S) − f (S) > 1 · f (Vopt), if l ≥ δ1. Proof. See Appendix B.3. Lemma 10. Given a set Rl of l RA sets generated by Alg. 4, with probability at most 1/N F (Rl, Vopt) − f (Vopt) < −2 · f (Vopt) if l ≥ δ2. Proof. See Appendix B.4. For the RA-T algorithm, intuitively we should assure that F (Rl, Vopt) and F (Rl, V ∗) are close to f (Vopt) and f (V ∗), respectively, where V ∗ is obtained by solving Prob- lem 2. As shown in Lemma 10, F (Rl, Vopt) is sufficient accu- rate if l ≥ δ2. Because V ∗ is unknown in advance, l has to be large enough such that the difference between F (Rl, S) and f (S) can be bounded for every S, and therefore δ1 is larger than δ2 by a factor of n. When F (Rl, Vopt) and F (Rl, V ∗) are both accurate, the RA-T algorithm is guaranteed to be effective, as shown in the next lemma. Lemma 11. Let S∗ be the set returned by Alg. 1 with input (F (Rl, S), V ). For any  ∈ (0, 1 1 2 f (V ∗) ≥ ( 2 ) and N ≥ 0, − )f (Vopt) N provided that holds with probability at least 1 − 2 l = max(δ1, δ2) Proof. By Lemma 9, f (V ∗) ≥ F (Rl, V ∗) − 1f (Vopt). 2 F (Rl, Vopt) and therefore, By Lemma 3, F (Rl, V ∗) ≥ 1 2 F (Rl, Vopt) − 1f (Vopt). Finally, combining f (V ∗) ≥ 1 Lemma 10 and Eq. (10), f (V ∗) ≥ ( 1 2 − )f (Vopt). Accord- ing to the union bound, the above inequality holds with probability at least 1 − 2/N. vii 1 do l = ∅; 2, 1, 2) by solving Eq System 1. Algorithm 6 RA-S Algorithm 1: Input: Υ, N, , k and 3; 1, δ∗ 2: Obtain (δ∗ 2, l∗ = δ3 and R∗ 3: l = δ∗ 4: while l ≤ 2 · δ∗ Generate l RA sets by Alg. 4 and add them into R∗ l ; 5: if l ≥ δ∗ 6: 7: 8: 9: 10: 11: 12: 13: 14: 1 then V ∗ ← Buchbinder's Algorithm (F (R∗ Return V ∗; Obtain (cid:101)fl∗ (V ∗) by l∗ simulations; V ∗ ← Buchbinder's Algorithm (F (R∗ if F (R∗ l = 2 ∗ l; l , V ∗) ≤ (1 + 3) · (cid:101)fl∗ (V ∗) then Return V ∗; l , S), V ); l , S), V ); else Running time. Now let us consider the running time of Alg. 5. Given Rl, calculating F (Rl, S) requires O(ln) time. Therefore, line 6 takes O(ln2) time. Because generating one RA set takes O(m), the running time of Alg. 5 is O(lm+ln2). Since l = max(δ1, δ2), l = O(n). The analysis in this section is summarized as follows. Theorem 5. Given the adjustable parameters  and N, with prob- ability at least 1 − 2/N, Alg. 5 returns a ( 1 2 − )-approximation running in O(n3) with respect to n. The success probability can be increased to 1 − 1/N by scaling N, which yields a ( 1 N )-approximation to the PM problem. Note that the running time of Alg. 5 can be further reduced. Given n, r, N and , the best choice of 1 and 2 is the one that can minimize max(δ1, δ2). That is, 2 − , 1 − 1 (1, 2) = arg min 2 2= 1+ 1 max(δ1, δ2). (13) In practice, there is no need to solve Eq. (13) directly, and, instead one can enumerate 1 from 0 to 1/2 with a small search step, namely 0.01. We will adopt such a setting in experiments. Generating RA set. It is worthy to note that, according to Def. 6, there is no need to sample the whole realization to obtain an RA set. Instead, one can obtain the adopted- reachable nodes along with the sampling of realization from the node selected in line 2 of Alg. 4 until no nodes can be further reached. Generating a RA set in this way can reduce the running time in practice but does not affect the worst- case running time of RA-T. 5.2 RA-S Algorithm In this section, we present another algorithm. Recall that in the RA-T algorithm, the number of generated RA sets should be large enough such that F (Rl, V ∗) − f (V ∗) and F (Rl, Vopt) − f (Vopt) are sufficiently small where V ∗ is obtained by solving Problem 2. In this section, we give another algorithm which generates enough RA sets such that F (Rl, Vopt) − f (Vopt) is small but controls the error F (Rl, V ∗) − f (V ∗) by Monte Carlo simulations. We call this algorithm as the RA-S algorithm where RA and S stand for RA set and simulation, respectively. algorithm, the parameters are 1, 2, 3, δ∗ The RA-S algorithm is formally shown in Alg. 6. In this 2 and δ3, where 1, δ∗ JOURNAL OF LATEX CLASS FILES, VOL. 14, NO. 8, AUGUST 2015 viii 3 and k are adjustable and other parameters are determined accordingly. In particular, 1, 2, δ∗ 2 are obtained by solving the following equations, Equation System 1. 1 and δ∗ − 1 = −  1 2 (ln N + n ln 2)(6 + 21r) 32 1r2 1 − 2 2(1 + 3) δ∗ 1 = δ∗ 2 ln N 2 = 2 2r2 1 = 2k · δ∗ δ∗ 1, 2 > 0 2 and , (14) (2 + 1r) ln N δ3 = 2 1r2 1 (resp. δ∗ In the above equation system, , N, n, r, k and 3 are given in advance. Because δ∗ 2) approaches infinity when 1 (resp. 2) approaches zero, there must be at least one set of variables that solves the equations. As shown in Alg. 6, with such parameters, we generate a family of collections of RA sets with sizes δ∗ 2 by a while loop from line 4 to 14. Within each iteration, we first generate a bunch of RA sets and then get a set V ∗ by solving Problem 2. Next, we obtain an estimate (cid:101)fl∗ (V ∗) of f (V ∗) by l∗ simulations, and check if F (Rl, V ∗) is smaller than (cid:101)fl∗ (V ∗) = δ3 by a 1 = 2k · δ∗ 2, 2· δ∗ 2, ..., δ∗ factor of (1 + 3). 5.2.1 Performance Guarantee. As shown in Alg. 6, the RA-S algorithm terminates either at line 8 or 13. Case a. Suppose that it terminates at line 13 and let l = {R1, ..., Rl} be the collection of RA sets used in the R∗ last iteration. According to line 5, a half of the RA sets in R∗ l are freshly generated in the last iteration and whether they can be generated depends on the other half of the RA sets ac- cording to the condition in line 12, which means the random variables x(R, Vopt) for R ∈ R∗ l are not independent. There- fore, the Chernoff bounds are not applicable. However, such dependency between the RA sets does not severely hurt the convergence of the sample mean and it turns out that the random variables x(R1, Vopt), ..., x(Rl, Vopt) in fact form a martingale [7]. Therefore, we can alternatively use concen- tration inequalities for martingales as shown in Appendix A. By using martingale, the accuracy of F (R∗ l , Vopt) can be ensured as shown in the following lemma. Lemma 12. If l ≥ δ∗ 2 F (R∗ l , Vopt) − f (Vopt) ≥ −2 · f (Vopt) (15) holds with probability at least 1 − 1/N. Furthermore, by setting l∗ as δ3, (cid:101)fl∗ (V ∗) is sufficiently Proof. See Appendix B.5. Lemma 13. Let V ∗ be the set produced in line 11 and (cid:101)fl∗ (V ∗) be the estimate of f (V ∗) obtained by l∗ simulations where l∗ = δ3. With probability at least 1 − 1/N, accurate. (cid:101)fl∗ (V ∗) − f (V ∗) ≤ 1 · f (Vopt) (16) Proof. See Appendix B.6. Eq. (16), (1 + 3)(cid:0)f (V ∗) + 1 · f (Vopt)(cid:1) ≥ (1 + 3)(cid:101)fl∗ (V ∗). Now we are ready to show the approximation ratio. Suppose that Eqs. (15) and (16) hold simultaneously. By According to line 12 in Alg. 6, (1 + 3)(cid:101)fl∗ (V ∗) ≥ F (R∗ l , V ∗) (1 + 3)(cid:0)f (V ∗) + 1 · f (Vopt)(cid:1) ≥ 1 2 F (R∗ and, by Lemma 3, F (R∗ l , Vopt). Therefore, 2 (1 − l , Vopt) ≥ 1 2 F (R∗ 2)f (Vopt), where the section inequality follows from Eq. (15). Rearranging the above inequality yields − 1)f (Vopt). l , V ∗) ≥ 1 f (V ∗) ≥ ( 1 − 2 2(1 + 3) Since, the parameters satisfy Eq System 1, we have 1 2 1 2 f (V ∗) ≥ ( − )f (Vopt). Case b. If Alg. 6 terminates at line 8, then l ≥ δ∗ 2 − , 1 − 2 1 N )- and it is sufficiently large to guarantee a ( 1 approximation, as shown in the following lemma. Lemma 14. If Alg. 6 terminates at line 6 returning a seed set V ∗, then f (V ∗) ≥ ( − )f (Vopt) holds with probability at least 1 − 2/N. Proof. The proof of this lemma is similar to that of the anal- ysis of the RA-T algorithm, except that we use martingale inequalities instead of Chernoff bound. Intuitively, making l ≥ δ∗ 1 ensures that Alg. 6 returns a good approximation in case that the stopping criterion in line 12 is never met. See. Appendix B.7 for the complete proof. By the above analysis, the RA-S algorithm has the same approximation ratio as that of the algorithms proposed in the previous sections. Because the number of RA sets is doubled in each iteration until it exceeds δ∗ 1, the running of RA-S algorithm is at most larger than that of the RA-T algorithm by a constant factor. Therefore, it is still O(n3) with respect to n and m. Parameter setting. As mentioned earlier, there are two 2 to δ∗ free parameters, k and 3. Because l ranges from δ∗ 1 = 2k · δ∗ 1 and δ∗ 2, k is number of iterations executed in Alg. 6 in the worst case. When k is large, the RA-S algorithm has to execute many iterations in the worst case but it also makes it possible that the RA-S algorithm can terminate at line 13 when l is much smaller than δ∗ 1. On the other hand, when k is small, the number of RA sets generated in each iteration becomes larger, but the worst case requires fewer iterations. Therefore, k decides the trade-off between the load size of each iteration and the number of iterations. 3 controls the stopping criterion (line 12) of the RA-S algorithm and it is correlated with 1 and 2 according to Eq System 1. In general, a small 3 implies a strict stopping criterion but reduces the number of RA sets required. Conversely, when 3 is large, the stopping criterion become less strict but more RA sets are needed as 1 and 2 become smaller. An optimization. As shown in Alg. 1, the Buchbinder's algorithm examines the nodes one by one via a loop from line 3 to line 11, and the approximation ratio holds regard- less of the examining order. Therefore, one may wonder that which examining order gives the best result. In this JOURNAL OF LATEX CLASS FILES, VOL. 14, NO. 8, AUGUST 2015 Dataset Wiki HepTh HepPh Youtube Pokec #Edges 104K 353K 422K 6.0M 30.6M #Nodes 7K 28K 35K 1.1M 1.6M Avg Degree 14.7 12.6 12.1 5.4 19.1 TABLE 1: Datasets. l paper, we sort the nodes by π(v) in a non-increasing order in advance. In particular, we first generate a bunch of RA sets Rl = {R1, ..., Rl} and use as an estimate of π(v) for sorting. We adopt such an examining order whenever the Buchbinder's algorithm is used. i=1 x(Ri,v) (cid:80)l Comparison with RA-T algorithm. The major difference between RA-T and RA-S is that they may use different numbers of RA sets. Although RA-T and RA-S algorithms have the same asymptotic running time, the RA-S algorithm can be more efficient in many cases. Recall that l is the number of RA sets used for estimating. In the RA-T algo- rithm, even if δ2 is much smaller than δ1, l has to be set as max(δ1, δ2) ≈ δ1 so that both the F (Rl, V ∗) and F (Rl, Vopt) are sufficiently accurate. In the RA-S algorithm, as shown in line 12 in Alg. 6, we utilize Monte Carlo simulation to check whether F (R∗ l , V ∗) is accurate enough, and therefore F (R∗ l , Vopt) can be a good estimate as long as l is larger than δ∗ 2. As a result, if the stopping criterion is satisfied when l is much smaller than δ∗ 1, RA-S returns a good solution without generating many RA sets. However, as observed in the experiments, RA-S does not dominate RA-T. Comparison with SPM and RPM. According to the anal- ysis in Sec. 4 and this section, RA-T and RA-S are theoret- ically efficient than SPM and RPM with respect to running time, which is also confirmed in experiments shown later in Sec. 6. However, SPM and RPM can be very fast under parallel computing systems as executing simulations and generating realizations are highly parallelizable. Further- more, the forward sampling method designed in Sec. 4 is potentially applicable to other USM problems beyond the PM problem, while RA-T and RA-S are proposed especially for the PM problem under the triggering model. 6 EXPERIMENTS In this section, we present the experiments for evaluating the proposed algorithms. Besides showing the performance of the algorithms proposed in this paper, the results herein also provide useful observations on the property of the PM problem. 6.1 Experimental Settings Our experiments are performed on a server with 16 GB ram and a 3.6 GHz quadcore processor running 64-bit JAVA VM 1.6. 6.1.1 Datasets The datasets selected for experiments are listed in Table 1. All the datasets are borrowed from Leskovec et al. [24]. Wiki is a who-votes-on-whom network collected from Wikipedia. HepTh and HepPh are arXiv citation graphs from the categories of high energy physics theory and high energy physics phenomenology, respectively. Youtube is a social ix network drawn from the Youtube video-sharing website. Pokec is a popular online social network in Slovakia. The original data of Youtube is undirected and we take each edge as a bi-directed edge to make it directed. 6.1.2 Models. As mentioned earlier, we adopt IC and LT models for exper- iments. For IC model, we consider two probability settings. One is constant probability (CP) setting where each edge has the propagation probability of 0.01 and the other one is the weighted cascade (WC) setting where p(u,v) = 1/N− v . To distinguish those two settings, we use IC-CP to denote the former and IC-WC for the later. For LT model, following the convention [1], [7], [21], the weight of edge (u, v) is set as 1/N− v . The price P , coupon C and intrinsics are normalized within [0,1], shown as follows. P is selected from [0.2, 0.6] and C is set as the 90% of P . After setting P and C, the intrinsic of each user is randomly generated from [P − C, 1] in uniform. Under this setting, every node can be an adopter once selected as a seed user. 6.1.3 Algorithms The algorithms considered in our experiments are shown as follows. We always set  and N as 0.4 and n, respectively. RA-S. This is the algorithm proposed in Sec. 5.2. For small graphs (Wiki, HepTh and HepPh) , we set that k = 5 and 3 = 0.1, and for large graphs (Youtube and Pokec) we set that k = 8 and 3 = 0.3. Other parameters are calculated by solving Eq System 1. Furthermore, we imme- diately return the seed set if the F (R∗ l , V ∗) calculated in two consecutive iterations decreases by less than 2% 9. RA-T. This is the algorithm proposed in Sec. 5.1. In ex- periments, we set the maximum of RA sets as 5,000,000. The results under this setting are also used later for discussing how many RA sets needed in obtaining good estimates. SPM. This is the algorithm proposed in Sec. 4.1. The parameter l here controls the number of simulations used for each estimating. In the previous works regarding the IM problem, the number of simulations is typically set as 10,000 to obtain an accurate estimation. However, in this paper, we set l as 2,000 for two reasons. First, it is reported in [12] that 1,000 simulations are sufficient for small graphs. Second, SPM takes more than 24 hours on Wiki even with l = 2, 000, which means it is not a good choice even if it could provide better performance with larger l. RPM. This is the algorithm proposed in Sec. 4.2. The number of realizations is set as 1,000 to make it terminate in a reasonable time. SPM and RPM are tested only on Wiki under IC-CP and LT as they are very time-consuming. MaxInf. As the first part of our objective function (Eq. (3)), the number of adopters is important in deciding the profit. Therefore, the algorithm that maximizes the num- ber of adopters can be a reasonable heuristic for the PM problem. Note that maximizing the number of adopters is essentially the IM problem. We adopt one of the state-of- the-art IM algorithms, D-SSA [8], as a heuristic algorithm for the PM problem. In particular, we set the size of the seed set to be n ∗ i/50 for i = 1, ..., 50. For each size, we 9. As observed in the experiments, F (R∗ l , S) decreases with the increase of l. Such a phenomenon is also observed in [12]. JOURNAL OF LATEX CLASS FILES, VOL. 14, NO. 8, AUGUST 2015 run the D-SSA to obtain a seed set and evaluate the profit by simulation. Finally, we select the result with the highest profit. This approach is denoted as MaxInf. HighDegree. Selecting the nodes with the highest degree is a popular heuristic for the maximization problems in social networks. We first randomly decide the size of seed nodes and then select the nodes with the highest degree as the seed set. For each graph, the above process is executed for 100 times. Finally, we select the result with the highest profit. The profits under the seed sets produced by the above algorithms are finally evaluated by 10,000 simulations. On large graphs, we show the results of RA-T and a simplified version of MaxInf where, instead of enumerating it from n/50 to n, the size of the seed set of MaxInf is set as the same as that of the result produced by RA-T. 6.2 Discussions The experimental results are shown Fig. 1. According to the experimental results, we make the following observations. RA-S and RA-T give the best overall performance for maximizing the profits. As shown in the figures, RA-S and RA-T consistently give the highest profit on the considered datasets under different settings. While SPM and RPM are also approximation algorithms, they cannot always produce high-quality seed sets. As shown in Figs. 1a and 1b, with l = 1, 000 on graph Wiki, RPM performs well under IC- CP model but considerably worse under LT model. Note that the gaps between the lines of different algorithms are not very significant because the price of the product is normalized within [0, 1]. MaxInf and HighDegree are sometimes comparable to RA-S and RA-T. As shown in Fig. 1, MaxInf performs relatively good when the price is very low. This is because when P is small almost all the nodes can be adopters once activated due to the setting of the intrinsic, and therefore the first part π() dominates the objective function f (). Since MaxInf aims to maximize π(), it has a good performance in this case. When the price is very high, except the seed users, most of the users cannot be adopters and therefore the objective function is almost monotone, which makes HighDegree accidentally comparable to RA-S e.g. Fig. 1c. As an extreme case, when P approaches to 1, the seed users cannot activate any neighbor and thus the objective function is strictly monotone. In this case, f (S) = (P − C)S only depends on the size of the seed set and the considered problem becomes less interesting. RA-S and RA-T are efficient with respect to running time. As shown in the graphs, RA-S and RA-T are even more efficient than the two heuristics, MaxInf and HighDe- gree, under certain circumstances. This is because the two heuristics still need to utilize Monte Carlo simulations to compare the profit under different seed sets. SPM and RPM are not scalable to large graphs as they also employ Monte Carlo simulations. For example, as shown in Figs 1a and 1b, on graph Wiki, SPM takes 38.6 and 21.2 hours under IC-IC and LT models, respectively. Comparison between SPM and RPM. As shown in Fig. 1a, comparing with SPM, RPM results in a higher profit and also takes much less time on graph Wiki under IC-CP model, x which gives the evidence that RPM is sometimes superior to SPM. However, RPM requires to load the realizations into memory and therefore it consumes more memory than SPM does. How many RA sets needed to produce a good seed set? As shown in Sec. 5, a great deal of effort has been devoted to computing the number of RA sets needed to produce a good seed set for maximizing the profit. This is actually the key problem for many influence related problems where the reverse sampling technique is used, as shown in [7], [11], [23], [25]. While more RA sets bring a higher quality of the seed sets, the quality increases very slow when a large number RA sets have already been used, and therefore one should stop generating RA sets if the current seed set is satisfactory. We observe that the algorithms proposed in this paper can sometimes overly generate RA sets. For example, on graph HepPh under the LT model, as shown in Fig. 1e, RA-S and RA-T have the similar performance but RA-S is ten times slower than RA-T, which means the number of RA sets used in RA-S is larger than that of used in RA-T. In fact, we believe there is room for improvement of the algorithms proposed in this paper. Profit V.s. Price. As observed in the experiments, the profit does not necessarily increase with the increase of price, especially under the LT model as shown in Figs. 1c and 1e. Such a phenomenon coincides with the setting of the intrinsic, because a large P narrows the set of users who are able to be adopters and therefore leads a decrease in total profit. Comparing to IM problem. It is worthy to note that, in general, the PM problem considered in this paper takes more time to solve than the IM problem does. Although the SPM algorithm proposed in this paper and the CELF algorithm [10] for IM problem are both designed with the idea of forward sampling, SPM is not able to run on HepPh even with l = 2, 000 while CELF terminates within 40 hours on the same graph as shown in [12]. There are several possible explanations for this phenomenon. First, the PM itself is an unconstrained optimization problem while the IM problem is a budgeted maximization problem, and thus PM requires more effort for sampling because π(Vopt) can be very large. Second, the lazy forward sampling method [10] significantly reduces the running time of the greedy algorithm for solving the IM problem without loss of the approximation guarantee. Unfortunately, currently we are not aware of any technique that can be used to boost the efficiency of the Buchbinder's algorithm (Alg. 1). On large graphs. The results on Youtube and Pokec are shown in Figs. 1h, 1g, 1i and 1j. We do not show the experimental results of HighDegree because it still performs worse than RA-T does. The results of RA-S are not included because it runs out of memory on those graphs. Note that our experiments are done on a machine with 16 GB ram and we observe that RA-S is able to run on large graphs if the size of ram is increased to 32 GB or more. According to the results, even though the number of RA sets is limited to 5,000,000, RA-T still performs much better than MaxInf does. On large graphs, MaxInf takes much less time than RA-T does, because the size of the seed set in MaxInf is given by the result of RA-T and consequently MaxInf no longer has to perform Monte Carlo simulations to compare JOURNAL OF LATEX CLASS FILES, VOL. 14, NO. 8, AUGUST 2015 xi (a) Wiki & IC-CP (b) Wiki & LT (c) HepTh & LT (d) HepTh & IC-CP (e) HepPh & LT (f) HepPh & IC-CP (g) Youtube & WC (h) Youtube & LT (i) Pokec & IC-CP (j) Pokec & WC Fig. 1: Experimental results. Each subset corresponds to one dataset under one model, where the left and right figures show the profit and running time ,respectively. the profits under the seed sets with different size. As shown in Figs. 1i and 1j, MaxInf can sometimes result in negative profit, which again indicates that maximizing the influence may not produce a high profit. As shown in Figs 1h, 1g, RA-T is able to terminate within 10 hours on Youtube and Pokec. 7 CONCLUSION AND FUTURE WORK In this paper, we consider the problem of maximizing the profit with the usage of the coupon in social networks. By integrating coupon system into the triggering spreading model, we formulate the PM problem as a combinatorial optimization problem. Based on our formulation, several approximation algorithms are provided together with their analysis. The performance of the proposed methods is eval- uated by experiments. The analysis of the PM problem is ac- tually applicable to other influence-related problems which are non-monotone submodular, and therefore it provides an algorithmic framework. The major future work of this paper is derived from the observations of the experiments. As discussed in Sec. 6.2, to improve the efficiency of RA-T and RA-S, one has to consider the number of RA sets generated for estimating. 0.20.30.40.50.6150200250300350400450500550600650PriceProfit RA−SRA−TRPMSPMMaxInfHighDegree0.20.30.40.50.605001000150020002500PriceMinutes RA−SRA−TRPMSPMMaxInfHighDegree0.20.250.30.350.40.450.50.550.610020030040050060070080090010001100PriceProfit RA−SRA−TRPMSPMMaxInfHighDegree0.20.30.40.50.60200400600800100012001400PriceMinutes RA−SRA−TRPMSPMMaxInfHighDegree0.20.30.40.50.615002000250030003500PriceProfit RA−SRA−TMaxInfHighDegree0.20.30.40.50.60510152025303540PriceRunning Time (Min) RA−SRA−TMaxInfHighDegree0.20.30.40.50.640060080010001200140016001800PriceProfit RA−SRA−TMaxInfHighDegree0.20.30.40.50.6020406080100120140160180PriceRunning Time (Min) RA−SRA−TMaxInfHighDegree0.20.30.40.50.6200025003000350040004500PriceProfit RA−SRA−TMaxInfHighDegree0.20.30.40.50.60102030405060PriceRunning Time (Min) RA−SRA−TMaxInfHighDegree0.20.30.40.50.64006008001000120014001600180020002200PriceProfit RA−SRA−TMaxInfHighDegree0.20.30.40.50.6102030405060708090100PriceRunning Time (Min) RA−SRA−TMaxInfHighDegree0.20.30.40.50.61.21.31.41.51.61.71.81.922.1x 105PriceProfit RA−TMaxInf0.20.30.40.50.60100200300400500600700800PriceRunning Time (Min) RA−TMaxInf0.20.30.40.50.6200025003000350040004500PriceProfit RA−SRA−TMaxInfHighDegree0.20.30.40.50.60102030405060PriceRunning Time (Min) RA−SRA−TMaxInfHighDegree0.20.30.40.50.6−3.5−3−2.5−2−1.5−1−0.500.51x 105PriceProfit RA−TMaxInf0.20.30.40.50.6020040060080010001200PriceRunning Time (Min) RA−TMaxInf0.20.30.40.50.6−505101520x 104PriceProfit RA−TMaxInf0.20.30.40.50.60100200300400500600700800PriceRunning Time (Min) RA−TMaxInf JOURNAL OF LATEX CLASS FILES, VOL. 14, NO. 8, AUGUST 2015 On one hand we need sufficient RA sets for an accurate estimate but, on the other hand, we should avoid generating too many RA sets to reduce the running time. Essentially, it asks for a good stop criterion for generating RA sets in such kind of algorithms like RA-S and RA-T. Second, any technique that can boost the efficiency of the Buchbinder's algorithm can definitely reduce the running time of RA-S and RA-T. Thus, finding such techniques is a promising future work. Finally, we note that the heuristics designed based on RA sets may effectively solve the PM problem while taking much less time. We leave this as part of our future work. ACKNOWLEDGMENTS This work was supported by National Natural Science Foundation of China under 61472272. REFERENCES [1] D. Kempe, J. Kleinberg, and ´E. Tardos, "Maximizing the spread of influence through a social network," in Proc. of the ninth SIGKDD. ACM, 2003, pp. 137 -- 146. [2] G. L. Nemhauser, L. A. Wolsey, and M. L. Fisher, "An analysis of approximations for maximizing submodular set functionsi," Mathematical Programming, vol. 14, no. 1, pp. 265 -- 294, 1978. S. Kalish, "A new product adoption model with price, advertising, and uncertainty," Management science, vol. 31, no. 12, pp. 1569 -- 1585, 1985. [4] K. Ailawadi, S. Gupta et al., "Sales promotions," History of Market- [3] ing Science, Singapore, pp. 463 -- 497, 2014. [5] N. Buchbinder, M. Feldman, J. Seffi, and R. Schwartz, "A tight linear time (1/2)-approximation for unconstrained submodular maximization," SIAM Journal on Computing, vol. 44, no. 5, pp. 1384 -- 1402, 2015. [6] C. Borgs, M. Brautbar, J. Chayes, and B. Lucier, "Maximizing social influence in nearly optimal time," in Proc. of the Twenty- Fifth Annual ACM-SIAM Symposium on Discrete Algorithms. SIAM, 2014, pp. 946 -- 957. [7] Y. Tang, Y. Shi, and X. Xiao, "Influence maximization in near-linear time: A martingale approach," in Proc. of the 2015 SIGMOD. ACM, 2015, pp. 1539 -- 1554. [8] H. T. Nguyen, M. T. Thai, and T. N. Dinh, "Stop-and-stare: Optimal sampling algorithms for viral marketing in billion-scale networks," in Proc. of the 2016 SIGMOD. ACM, 2016, pp. 695 -- 710. [9] P. Domingos and M. Richardson, "Mining the network value of customers," in Proc. of the 7th SIGKDD. ACM, 2001, pp. 57 -- 66. [10] J. Leskovec, A. Krause, C. Guestrin, C. Faloutsos, J. VanBriesen, and N. Glance, "Cost-effective outbreak detection in networks," in Proc. of the 13th SIGKDD. ACM, 2007, pp. 420 -- 429. [11] Y. Tang, X. Xiao, and Y. Shi, "Influence maximization: Near- optimal time complexity meets practical efficiency," in Proc. of the 2014 SIGMOD. ACM, 2014, pp. 75 -- 86. [12] A. Arora, S. Galhotra, and S. Ranu, "Debunking the myths of influence maximization: An in-depth benchmarking study," in Proc. of the SIGMOD, 2017. [13] W. Chen, C. Wang, and Y. Wang, "Scalable influence maximization for prevalent viral marketing in large-scale social networks," in Proc. of the 16th SIGKDD. ACM, 2010, pp. 1029 -- 1038. [14] S. Cheng, H. Shen, J. Huang, G. Zhang, and X. Cheng, "Stat- icgreedy: solving the scalability-accuracy dilemma in influence maximization," in Proc. of the 22nd ACM international conference on Information & Knowledge Management. ACM, 2013, pp. 509 -- 518. [15] D. Arthur, R. Motwani, A. Sharma, and Y. Xu, "Pricing strategies for viral marketing on social networks," in International Workshop on Internet and Network Economics. Springer, 2009, pp. 101 -- 112. [16] F. Zhou, R. J. Jiao, and B. Lei, "Bilevel game-theoretic optimization for product adoption maximization incorporating social network effects," IEEE Transactions on Systems, Man, and Cybernetics: Sys- tems, vol. 46, no. 8, pp. 1047 -- 1060, 2016. xii [17] Z. Lu, H. Zhou, V. O. Li, and Y. Long, "Pricing game of celebrities in sponsored viral marketing in online social networks with a greedy advertising platform," in Proc. of the 2016 ICC. IEEE, 2016, pp. 1 -- 6. [18] Y. Zhu, Z. Lu, Y. Bi, W. Wu, Y. Jiang, and D. Li, "Influence and IEEE, profit: Two sides of the coin," in Proc. of the 13th ICDM. 2013, pp. 1301 -- 1306. [19] Y. Yang, X. Mao, J. Pei, and X. He, "Continuous influence max- imization: What discounts should we offer to social network users?" in Proc. of the 2016 SIGMOD. ACM, 2016, pp. 727 -- 741. [20] W. Lu and L. V. Lakshmanan, "Profit maximization over social networks," in Proc. of the 12th ICDM. IEEE, 2012, pp. 479 -- 488. [21] J. Tang, X. Tang, and J. Yuan, "Profit maximization for viral marketing in online social networks," in Proc. of the 24th ICNP. IEEE, 2016, pp. 1 -- 10. [22] U. Feige, V. S. Mirrokni, and J. Vondrak, "Maximizing non- monotone submodular functions," SIAM Journal on Computing, vol. 40, no. 4, pp. 1133 -- 1153, 2011. [23] A. G. Tong, W. Wu, L. Guo, D. Li, C. Liu, B. Liu, and D.-Z. Du, "An efficient randomized algorithm for rumor blocking in online social networks," in Proc. of the 36th INFOCOM. IEEE, 2017. [24] J. Leskovec and A. Krevl, "SNAP Datasets: Stanford large network dataset collection," http://snap.stanford.edu/data, Jun. 2014. [25] W. Lu, W. Chen, and L. V. Lakshmanan, "From competition to complementarity: comparative influence diffusion and maximiza- tion," Proc. of the VLDB Endowment, vol. 9, no. 2, pp. 60 -- 71, 2015. [26] R. Motwani and P. Raghavan, Randomized algorithms. Chapman & Hall/CRC, 2010. Guang-mo Tong is a Ph.D. candidate in the Department of Computer Science at the University of Texas at Dallas. He received his BS degree in Mathematics and Applied Mathematics from Beijing Institute of Tech- nology in July 2013. His research interests include computational social systems, data communication and real-time systems. He is a student member of the IEEE. Weili Wu (M00) is currently a Full Professor with the Department of Computer Science, the University of Texas at Dallas, Dallas, TX, USA. She received the Ph.D. and M.S. degrees from the Department of Computer Science, University of Minnesota, Minneapolis, MN, USA, in 2002 and 1998, respectively. Her research mainly deals with the general research area of data communication and data management. Her research focuses on the design and analysis of algorithms for optimization problems that occur in wireless networking environments and various database systems. Ding-Zhu Du received the M.S. degree from the Chinese Academy of Sciences in 1982 and the Ph.D. degree from the University of California at Santa Barbara in 1985, under the supervision of Professor Ronald V. Book. Before settling at the University of Texas at Dallas, he worked as a professor in the Department of Computer Science and Engineering, University of Minnesota. He also worked at the Mathematical Sciences Research Institute, Berkeley, for one year, in the Department of Mathe- matics, Massachusetts Institute of Technology, for one year, and in the Department of Computer Science, Princeton University, for one and a half years. He is the editor-in-chief of the Journal of Combinatorial Opti- mization and is also on the editorial boards for several other journals. Forty Ph.D. students have graduated under his supervision. He is a member of the IEEE Case 1. (ai ≥ 0 and bi ≤ 0). In this case, Yi = Yi−1 i−1 + vi and i ) = 0. and Xi = Xi−1 + vi, and therefore, S∗ h(Yi)− h(Yi−1) = 0. If vi ∈ S∗ If vi /∈ S∗, then by the submodularity, i−1, then h(S∗ i−1)− h(S∗ i = S∗ xiii h(S∗ i−1) − h(S∗ i ) ≤ h(Yi−1 − vi) − h(Yi−1) {By Eq. (5)} · L∗ = bi ≤ 0. 2 n i−1)−h(S∗ i ) ≤ 0 ≤ ai 2 . 1 2 h(S∗ (h(Yi) − h(Yi−1)) Therefore, in both cases, we have h(S∗ Since h(Yi) = h(Yi−1), i−1) − h(S∗ i ) ≤ 1 a + 2 (h(Xi−1 + vi) − h(Xi−1) + h(Yi) − h(Yi−1)) 1 2 {By Eq. (5)} (h(Xi−1 + vi) − h(Xi−1) + h(Yi) − h(Yi−1)) + (h(Xi) − h(Xi−1) + h(Yi) − h(Yi−1)) + = ≤ 1 2 ≤ 1 2  n · L∗  n · h(S∗) Thus, this case is proved. Case 2. (ai < 0 and bi ≥ 0). This case can be proved in a similar manner as that of Case 1. Case 3. (ai ≥ 0 and bi > 0). In this case, with probability ai/(ai + bi) (resp. bi/(ai + bi)) that Xi ← Xi−1 + vi and Yi ← Yi−1 (resp. Xi ← Xi−1 and Yi ← Yi−1 \ vi) happen. Therefore, E[h(Xi) − h(Xi−1) + h(Yi) − h(Yi−1)] JOURNAL OF LATEX CLASS FILES, VOL. 14, NO. 8, AUGUST 2015 APPENDIX A CHERNOFF BOUND AND MARTINGALE Let Zi ∈ [0, 1] be l i.i.d random variables where E(Zi) = µ. The Chernoff bounds [26] states that Pr Zi − l · µ ≥ δ · l · µ ), (17) (cid:105) ≤ exp(− l · µ · δ2 (cid:105) ≤ exp(− l · µ · δ2 2 + δ 2 (cid:104)(cid:88) (cid:104)(cid:88) and Pr for δ > 0. Martingale method provides good error estimates for a sequence of variables where the independence assumptions is not required. It has been proved by Tang et al. [21] that, for any seed set S and a sequence of RA sets R1, ..., Rl, the random variables x(Ri, l), for 1 ≤ i ≤ l, are martingales and they satisfy the following concentration inequalities, for any (cid:88) δ ≥ 0, (cid:88) x(Ri, S) − l · µ ≥ δ · l · µ] ≤ exp(− l · µ · δ2 2 + 2 3 δ x(Ri, S) − l · µ ≤ −δ · l · µ] ≤ exp(− l · µ · δ2 ), (20) and (19) Pr[ Pr[ ) 2 and where µ = E[x(Ri, l)] = π(S) n . APPENDIX B PROOFS B.1 Proof of Theorem 2 Recall that, in the i-th iteration of the loop, node vi is considered, and Xi and Yi are the subsets created in line 9 or 11. Let S∗ be the optimal solution and define that i = (S∗ ∪ Xi) ∩ Yi for 1 ≤ i ≤ n. Note that S∗ 0 = S∗ S∗ and S∗ n = Xn = Yn. For a set S and a node v, define that S +v = S∪{v} and S−v = S\{v}. Because Alg. 1 is in fact a randomized algorithm, we consider the expected value of h(Xn). The following is a key lemma to prove Theorem 2. Lemma 15. For each 1 ≤ i ≤ n, i−1) − h(S∗ i )] E[h(Xi) − h(Xi−1) + h(Yi) − h(Yi−1)] + E[h(S∗ ≤ 1 2 · h(S∗) 2 n Proof. It suffices to prove that it is true conditioned on every possible event by the i-th iteration. Now we fix Xi−1 and Yi−1 and consider the i-th iteration. By Eq. (1), h(Xi−1 + vi)−h(Xi−1)+h(Yi−1−vi)−h(Yi−1) is always non-negative due to the submodularity of h(). Thus, ai + bi = h(Xi−1 + vi) − h(Xi−1) + +h(Yi−1 − vi) − h(Yi−1) + {By Eq. (5)} · L∗ · L∗ 2 n 2 n ≥ h(Xi−1 + vi) − h(Xi−1) + h(Yi−1 − vi) − h(Yi−1) ≥ 0, and there are three cases to consider: Zi − l · µ ≤ −δ · l · µ ), (18) ≤ h(Yi−1 − vi) − h(Yi−1) + = ≥ = = (h(Xi−1 + vi) − h(Xi−1)) (h(Yi−1 − vi) − h(Yi−1)) ai ai + bi bi + ai + bi {By Eq. (5)} ai ai + bi bi + ai + bi ai ai + bi i + b2 a2 i ai + bi (h(Xi−1 + vi) − h(Xi−1) − 2 n (h(Yi−1 − vi) − h(Yi−1) − 2 n (bi − 4 n · L∗) + (ai − 4 n · L∗ ≥ a2 ai + bi bi − 4 n · L∗) · L∗) · L∗) − 4 n · h(S∗). (21) i + b2 i ai + bi i−1) − h(S∗ Now let us consider E[h(S∗ i )]. Note that E[h(S∗ ai i−1) − h(S∗ i )] (h(S∗ = i−1) − h(S∗ i−1) − h(S∗ i−1 + vi)) i−1 − vi)) (h(S∗ ai + bi bi + ai + bi JOURNAL OF LATEX CLASS FILES, VOL. 14, NO. 8, AUGUST 2015 If vi ∈ S∗ i−1 + vi) = 0 and i−1 then h(S∗ i−1) − h(S∗ i−1) − h(S∗ h(S∗ {By submodularity} i−1 − vi) ≤ h(Xi−1 + vi) − h(Xi−1) {By Eq. (5)} If vi /∈ S∗ · L∗ = ai 2 n i−1) = 0 and ≤ h(Xi−1 + vi) − h(Xi−1) + i−1 then h(S∗ i−1 − vi) − h(S∗ i−1 − vi) i−1) − h(S∗ h(S∗ {By submodularity} ≤ h(Yi−1 − vi) − h(Yi−1) {By Eq. (5)} ≤ h(Yi−1 − vi) − h(Yi−1) + · L∗ = bi. 2 n Therefore, in either case, E[h(S∗ Together with Eq. (21), E[h(S∗ h(Xi−1) + h(Yi) − h(Yi−1)] + 2 i−1) − h(S∗ n · h(S∗) i−1) − h(S∗ i )] ≤ ai bi . ai + bi E[h(Xi) − i )] ≤ 1 2 Now new are ready to prove Theorem 2, as shown in the 2 − ) · h(S∗). following lemma. Lemma 16. E[h(Xn)] ≥ ( 1 Proof. Summing the inequality of Lemma 15 for i from 1 to n E[h(Xn)+h(Yn)−h(X0)− yields that E[h(S∗ h(Y0)] + 2 · h(S∗). Since S∗ n = Xn = Yn, we have E[h(Xn)] ≥ ( 1 n)] ≤ 1 0 )−h(S∗ 2 − ) · h(S∗). 0 = S∗ and S∗ 2 S and therefore π(S) =(cid:80) 5, π(S, v) = (cid:80) E[x(S, Rv)] =(cid:80) B.2 Proof of Lemma 7 Let π(S, v) be the probability that v can be an adopter under v∈V π(S, v) due to the linearity of expectation. Let GS v be the set of the realizations where v is an adopter under S and Pr[g] be the probability that g can be sampled according the triggering distribution. By Lemma Pr[g]. On the other hand, let x(S, Rv) be the conditional variable of x(S, R) when v is selected in line 2 of Alg. 4. Thus, E[x(S, R)] = . Note that v is an adopter under S in g if and only if at least one node in S in reverse-adopted-reachable to v. Therefore, Pr[g] = π(S, v), which completes the (cid:80) v∈V E[x(S,Rv)] g∈GS n v g∈GS v proof. B.3 Proof of Lemma 9 By rearrangement, Pr[F (Rl, S)− f (S) > 1f (Vopt)] is equal ]. According to Pr[(cid:80)l i=1 x(Ri, S) − lπ(S) n > l · π(S) 1·f (Vopt) P·π(S) to Chernoff bound, this probability is no larger than n exp(− l · π(S) n · ( 1·f (Vopt) P·π(S) )2 2 + 1·f (Vopt) P·π(S) ). By Eq. (4) and π(S) ≤ n, it is further no larger than 1·(P−C)2 exp(− l·2 2P 2+1P·(P−C) ). Finally, by Eq. (11), this probability N·2n . Since there are at most 2n subsets, by the is at most union bound, the lemma holds. 1 xiv to Pr[(cid:80)l B.4 Proof of Lemma 10 By rearrangement, Pr[F (Rl, Vopt) − f (Vopt) ≤ −2f (Vopt)] ≤ −l · is equal 2·f (Vopt) π(Vopt) P·π(Vopt) ]. By Chernoff bound, this probability is no i=1 x(Ri, Vopt) − l · π(Vopt) n n larger than n P·π(Vopt) )2 exp(− l · π(Vopt) By Eq. (4) and π(S) ≤ n, exp(− l·2 than 1 N . · ( 2·f (Vopt) 2 it is then no larger than ), which, by Eq. (12), is equal to or smaller 2·(P−C)2 2P 2 ). B.5 Proof of Lemma 12 This proof of this lemma is exactly the same as that of Lemma 10 because δ∗ 2 = δ2 and the lower tail inequality of Chernoff bound (i.e. Eq. (18)) is identical to that of the Martingale (i.e. Eq. (20)). B.6 Proof of Lemma 13 Pr[(cid:101)fl(V ∗) − f (V ∗) > 1 · f (Vopt)] = Pr[P ·(cid:101)πl(V ∗) − P · π(V ∗) > 1 · f (Vopt)] = Pr[l · (cid:101)πl(V ∗) > l · π(V ∗) ≤ Pr[l · (cid:101)πl(V ∗) − l · π(V ∗) {Since f (Vopt) ≥ n(P − C)} − l · π(V ∗) > l · π(V ∗) n n n n n n ] 1f (Vopt) P · π(V ∗) 1n(P − C) P · π(V ∗) ] Applying the Chernoff bound, the above probability is no larger than exp(− l· π(V ∗ ) n · 2 2+ 1nr π(V ∗ ) π(V ∗) ≤ n, it is no larger than 1/N. 1n2 r2 π2(V ∗ ) ). Finally, by Eq. (14) and B.7 Proof of Lemma 14 We first prove a result which is analogous to Lemma 9. Let Rl = {R1..., Rl} be the RA sets used in line 7 of Alg. 6 and V ∗ be the final result returned in line 8, where l ≥ δ∗ 1. For any seed set S, by rearrangement, Pr[F (Rl, S) − f (S) > 1f (Vopt)] is equal to x(Ri, S) − l · π(S) n > l · π(S) n 1 · f (Vopt) P · π(S) ]. l(cid:88) i=1 Pr[ Applying Eq. (20) yields that the above probability is no larger than exp(− l · π(S) n · ( 1·f (Vopt) P·π(S) )2 2 + 21·f (Vopt) 3P·π(S) ). By Eq. (4) and π(S) ≤ n, this probability is no larger than exp(− 3l · 2 1 · (P − C)2 6P 2 + 21P · (P − C) ). Finally, replacing l with δ∗ exp(− 3l · 2 1 implies that 1 · (P − C)2 6P 2 + 21P · (P − C) ) ≤ 1 N · 2n . Since there are at most 2n subsets, with probability at most 1/N, there exists some S ⊆ V such that F (Rl, S) − f (S) > JOURNAL OF LATEX CLASS FILES, VOL. 14, NO. 8, AUGUST 2015 1 · f (Vopt), which means, F (Rl, V ∗) − f (V ∗) ≤ 1 · f (Vopt) holds with the probability at least 1 − 1/N. Therefore, xv f (V ∗) ≥ F (Rl, V ∗) − 1 · f (Vopt) {By Lemma 3} ≥ 1 F (Rl, Vopt) − 1 · f (Vopt) 2 {By Lemma 12} (1 − 2)f (Vopt) − 1 · f (Vopt) ≥ 1 2 {By Eqs 1} 1 2 − ) · f (Vopt) ≥ ( holds with probability at least 1 − 2/N.
1903.02706
1
1903
2019-03-07T03:02:00
Twitter Speaks: A Case of National Disaster Situational Awareness
[ "cs.SI", "cs.CY", "stat.AP", "stat.ML" ]
In recent years, we have been faced with a series of natural disasters causing a tremendous amount of financial, environmental, and human losses. The unpredictable nature of natural disasters' behavior makes it hard to have a comprehensive situational awareness (SA) to support disaster management. Using opinion surveys is a traditional approach to analyze public concerns during natural disasters; however, this approach is limited, expensive, and time-consuming. Luckily the advent of social media has provided scholars with an alternative means of analyzing public concerns. Social media enable users (people) to freely communicate their opinions and disperse information regarding current events including natural disasters. This research emphasizes the value of social media analysis and proposes an analytical framework: Twitter Situational Awareness (TwiSA). This framework uses text mining methods including sentiment analysis and topic modeling to create a better SA for disaster preparedness, response, and recovery. TwiSA has also effectively deployed on a large number of tweets and tracks the negative concerns of people during the 2015 South Carolina flood.
cs.SI
cs
Twitter Speaks: A Case of National Disaster Situational Awareness Journal of Information Science XX(X):1 -- 17 c(cid:13)The Author(s) 2017 Reprints and permission: sagepub.co.uk/journalsPermissions.nav DOI: 10.1177/ToBeAssigned www.sagepub.com/ Amir Karami1, Vishal Shah2, Reza Vaezi3, Amit Bansal2 Abstract In recent years, we have been faced with a series of natural disasters causing a tremendous amount of financial, environmental, and human losses. The unpredictable nature of natural disasters behavior makes it hard to have a comprehensive situational awareness (SA) to support disaster management. Using opinion surveys is a traditional approach to analyze public concerns during natural disasters; however, this approach is limited, expensive, and time-consuming. Luckily the advent of social media has provided scholars with an alternative means of analyzing public concerns. Social media enable users (people) to freely communicate their opinions and disperse information regarding current events including natural disasters. This research emphasizes the value of social media analysis and proposes an analytical framework: Twitter Situational Awareness (TwiSA). This framework uses text mining methods including sentiment analysis and topic modeling to create a better SA for disaster preparedness, response, and recovery. TwiSA has also effectively deployed on a large number of tweets and tracks the negative concerns of people during the 2015 South Carolina flood. Keywords Flood, Natural Disaster, Situational Awareness, Sentiment Analysis, Topic Model, Text Mining, Twitter Introduction The growth of social media has provided an opportunity to track people's concerns in a new way. Twitter has 316 million users [1], provides capability of real-time feedback, and utilizes time stamp to provide conversation updates to users. Therefore, Twitter's potential as a reliable and relevant as a data source 1School of Library and Information Science, University of South Carolina, USA 2Computer Science & Engineering Department, University of South Carolina, USA 3Coles College of Business, Kennesaw State University, USA Corresponding author: Amir Karami Email: [email protected] Prepared using sagej.cls [Version: 2016/06/24 v1.10] 2 Journal of Information Science XX(X) is evident and provides a unique opportunity to understand users' concerns [2, 3]. In contrast to surveys and surveillance networks that can take weeks or even years to collect data, Twitter is publicly accessible with no waiting time. SA is "all knowledge that is accessible and can be integrated into a coherent picture, when required, to assess and cope with a situation" [4]. Obtaining reliable and accurate information and providing access to knowledge derived from the collected data is the main concern in situational awareness. Thus, SA and its inherent processes play an essential role in helping people facing a natural disaster. During a natural disaster, people immediately try to collect or share information to keep them away from possible dangerous situations [5]. Developing high level of Situational Awareness (SA) by analyzing real-time big data helps to become more effective in disaster management [6, 7]. In October 2015 hurricane Joaquin led to an unusually high amount of rainfall in the state of South Carolina (SC). The precipitation ranged from 11 inches to 26 inches in different areas and caused server flooding in the state. This flood caused more than $12 billion damage to roads, homes, and infrastructures with 19 dead [8, 9]. Twitter users expressed their feelings and opinions during the 2015 SC flood through their Tweets. This valuable time-sensitive data can improve SA development and give all involved parties a more accurate picture of the situation during the flood. Crowdsourced data such as social media data is a rapid and accessible source for SA development [10]. In other words, understanding users' concerns and their emotions can help disaster managers develop a better real-time SA and decision making plans [11, 12]. During the height of the 2015 SC flood, thousands of people were twitting about the flood on an average of 3000 tweets per hour. One can imagine that manually analyzing this many tweets is not easily possible; therefore, new customized approaches are necessary to disclose hidden semantic features from social media. This study proposes an analytical framework, Twitter Situational Awareness (TwiSA), to analyze unstructured flood-related tweets to better understand temporal concerns of people affected by this natural disaster. The proposed framework employs both sentiment analysis and topic modeling to uncover temporal patterns of public concerns to provide a better SA. We apply TwiSA on a large number of tweets and tracks the negative concerns of people during the 2015 SC flood. Related Work Twitter data has been used for a broad range of applications such as business [13, 14, 15, 16, 17], politics [18, 19, 20, 21, 22, 23], and health [24, 25, 26, 27, 28, 29]. In this section, we review the applications of Twitter data in natural disasters including fire, flood, earthquake, hurricane and typhoon, and volcano eruption. Abel et al. (2012) developed a tool, called Twitcident, to collect fire-related tweets and search tweets using queries [30]. Sinnappan et al. (2010) collected tweets and used qualitative approach to find meaningful categorization of fire-related tweets [31] Earthquake-related studies proposed frameworks to improve disaster management process. These included using data mining and natural language processing for damage detection and assessment of earthquakes [32], proposing a probabilistic spatiotemporal model for reporting earthquake related events [33], developing a detection algorithm based on the frequency of tweets to detect earthquake [34], applying classifier methods on tweets to detect earthquake [35, 36], using qualitative approach to analyze Prepared using sagej.cls Karami et al. 3 people's behavior after an earthquake [37], applying a keyword level analysis to track social attitudes during and after an earthquake [38], and analyzing dynamic of rumor mill in tweets [39]. Literature also contains methods for disaster management during hurricanes and typhoon. This research area analyzed online public communications by police and fire departments in Twitter and Facebook [40], used classification methods to detect fake images during the hurricane [41], and analyzed external factors such as geolocation and internal factors (e.g. geolocation, and stakeholders power) in a small sample of tweets to find patterns of information dissemination [42]. Recently, a study mapped online users' sentiments to track their changes during a hurricane [11]. Twitter data was also used to help disaster management using qualitative content analysis to categorize information inside the Twitter data during a volcano eruption [43]. Flood-related studies developed numerous frameworks to improve disaster management during floods. These studies tracked users' behavior during a flood [44], combined georeferenced social media messages and geographic features of flood phenomena [45], used machine learning techniques to find tweets reporting damage [46], mapped geo-tagged tweets to directly support geotechnical experts for reconnaissance purposes [47], analyzed crisis relevant information from Twitter using related keywords and geo-tagged tweets [48], investigated the correlation between location and the types of URLs inside tweets [49], explored the discursive aspects of Twitter communication with qualitative analysis [50], analyzed the related tweets with qualitative data coding to find useful information [10], and used keyword analysis to determine the types of information in the flood-related tweets [51]. Although it is evident from the literature that past research on the use of social media during a natural disaster provides useful insight into disaster management, unpredictable nature of natural disasters provides a great motivation for disaster responders to constantly improve disaster management by exploring new perspectives. Thus, we believe we can improve disaster management through better integration of SA into the management practices specially when it comes to people concerns and negative feelings. To our knowledge no other research studied the concerns of people behind their negative feelings for having a better situational awareness. This study proposes an analytical framework to explore a large number of tweets using sentiment analysis and topic modeling for tracking temporal patterns of public negative concerns during the 2015 SC flood. Methodology and Results This paper proposes a framework, Twitter Situational Awareness (TwiSA), with four components: data collection, sentiment analysis, temporal topic discovery, and topic content analysis. Data Collection There are two methods to collect a large number of tweets in TwiSA. One method is to retrieve data using Twitter APIs (Application Programming Interfaces) [52], and the other method is to ask an independent service to provide the data. The first method, despite being free, is limited in that one can only retrieve a small portion of relevant tweets. Therefore, we asked an independent company, Gnip [53], to extract 100% of tweets related to our research. Similar to Palen et al. (2010) [44], we ordered the queries in Table 1 to collect tweets for the days having flood danger or flood side effect. One million tweets were filtered based on 13 days in October 2015. We chose this time frame because it represents a period that starts with the highest amount of rainfall (October 3, 2015) and ends with the last day for boil advisory Prepared using sagej.cls 4 Journal of Information Science XX(X) (October 15, 2015) [8]. It is worth mentioning that we did not remove retweets and the tweets containing URLs from our dataset but the word "rt" and URLs were removed from the collected tweets. Table 2 shows a sample of tweets that are related to insurance and damage issues using the #scflood query. Table 1. Queries for Twitter Data Collection #floodsc OR #scflood2015 OR #SCFloodRelief OR #southcarolinastrong OR #prayforsc OR #scflood OR #scflooding OR #FloodGSSCMMwithlove OR #floodingsc OR #flood OR flood Table 2. A Sample of Tweets Tweet 1 Tweet 2 How many South Carolinians have flood insurance? Few.They'll be looking to federal gov't or their tight-fisted governor for help. #SCFlood Damage inside Student Activities room at Westwood. #SCFlood Sentiment Analysis Sentiment analysis discloses the overall feelings inside text data [54]. Learning-based and lexicon-based methods are two main approaches for sentiment analysis [55]. The first approach uses machine learning classifiers when there is prior knowledge about data categories. In this case, a sample of the data is first labeled by human raters such as assigning spam and non-spam labels to a sample of emails [54]. The second approach, a cost-effective one, finds the frequency of a predefined dictionary of positive and negative terms to disclose sentiment in the data when there is not any prior knowledge about its categories [56]. We did not have any prior knowledge about the categories of the tweets in this research; therefore, we applied the second approach to find positive, negative, and neutral tweets. Linguistic Inquiry and Word Count (LIWC) [57] is a linguistics analysis tool that reveals thoughts, feelings, personality, and motivations in a corpus based on lexicon-based approach. This software assumes that the frequency of words can reveal overall tone in the corpus [58, 59, 60]. This tool applies a simple word-count process in text documents and maps each word in the documents on the already developed internal LIWC dictionaries in different categories such as negative emotion [61]. LIWC has good sensitivity value, specificity value, and English proficiency measure [62]. Comparing to competitors such as deep learning, this tool can be used alone or be combined with other methods [63]. Applying LIWC on the collected tweets shows that there are 217,074 negative tweets, 529,150 neutral tweets, and 217,183 positive tweets. When people are exposed to unpredictable events, they show unpleasant negative feelings that come from the presence of threats with undesirable outcomes [64, 65]. We used the negative tweets for the next step to identify unpleasant elements of the SC flood through temporal topic discovery analysis (Figure 1). Figure 2 shows that the number of negative tweets per day has changed from ∼12,700 tweets to ∼30,000 tweets with average ∼16,700 tweets per day. Prepared using sagej.cls Karami et al. 5 Twitter 23.18% Negative Tweets 53.63% Neutral Tweets 23.19% Positive Tweets Figure 1. Sentiment Analysis of the SC Flood Tweets 30 022 , 10/03/2015 10/04/2015 10/05/2015 10/06/2015 10/07/2015 10/08/2015 10/09/2015 10/10/2015 10/11/2015 10/12/2015 10/13/2015 10/14/2015 10/15/2015 16 198 , 18 710 , 20 319 , 17 803 , 17 575 , 15 632 , 12 745 , 12 783 , 13 208 , 13 813 , 14 839 , 13 427 , Figure 2. Number of Negative Tweets per Day Temporal Topic Discovery Next we turned our attention to detect topics among the pool of the 217,074 negative tweets to showcase the proposed framework. Different approaches for detecting the topics in a corpus have been developed based on the neural network and statistical distributions. During the last decade, the neural network has been considered for improving data analysis methods such as the deep neural network (DNN) [66]. The models based on neural network are costly and time-consuming methods [67, 68, 69] that require a lot of training data along with having a chance of overfitting problem [70]. For example, one study needed to train millions of tweets for the pre-training step [71] that is also a barrier for having an efficient real-time streaming data [72]. In addition, the deep learning methods haven't shown significant performance over other methods in small or medium size corpora [72, 66]. According to the literature, Latent Dirichlet Allocation (LDA) [73] is a valid [74, 75, 76, 77] and widely used [78, 3] model for discovering topics in a corpus [79]. LDA assumes that there are multiple topics in a corpus and each topic is a distribution over corpus's vocabulary and can be inferred from word-document co-occurrences [73, 80, 81]. Prepared using sagej.cls 6 Journal of Information Science XX(X) LDA assigns each word in a document to each of topics with a different degree of membership using a statistical distribution [82]. For example, in a given corpus, LDA assigns "flood," "earthquake," and "hurricane" into a topic with "natural disaster" theme. TwiSA uses LDA to identify topics in the negative tweets. This research uses Mallet implementation of LDA [83] that uses Gibbs sampling that is a specific form of Markov Chain Monte Carlo (MCMC) [84] with removing standard stopwords list and having 1000 iterations to detect top 25 topics per day (325 topics in total) in the negative tweets per each of the 13 days. Table 3. Flood Topics Examples Victims scflood victims flooding disaster death Bridge Damage disaster bridge flooded natural flood Damage & Costs Drinking Water Insurance Road Damage Roof Damage damage property loss roadway construction Flood Report alert warning effect flood remain water drink boil bottle clean families insurance homeowners destroyed support Homelessness Power Lost flood homeless lives woman boy lost flood home power family road damage roadway st exit Animal Animal Shelter dog poor find roof damage repair danger home Topic Content Analysis The last component of TwiSA analyzes extracted topics. This component labels and categorizes 25 topics per day, analyzes frequency of them, and explains possible reasons behind the detected topics comparing with official and published reports. We manually labeled the negative topics (concerns) for each of the 13 days between 10/03/2015 and 10/15/2015. For example, if "road", "damage", "roadway", "st", and "exit" are in a topic, we labeled the topic "Road Damage". Table 3 shows some examples of the detected topics. It is worth mentioning that the quantity of topics/day were more than 11 topics but we assigned related topics to one category. For example, if some topics represent injured people and victims, we assigned just "Victims" label to each of those topics. The analyzed topics were categorized into 11 unique ones with different frequencies (Table 4). This analysis indicates that damages and animal support are the most and the least discussed negative topics, respectively. Moreover, figure 3 shows that the number of unique negative topics per day has changed from 2 to 8 during the time period considered for this research. The highest number of topic diversity is on the fourth, the fifth, and the sixth days, and the lowest number of topic diversity is on the last day. This figure indicates growing rate of topic diversity between the first day and the sixth day, and declining rate of topic diversity between the seventh day and the last day. It seems that SC disaster responders have tried to reduce people's negative concerns between the sixth day and the thirteenth day. Table 5 shows the topics' distribution for each of the 13 days. We compare our results with official and published reports to explain possible reasons behind the detected topics. "Victims" is the most frequent negative topic that is about the people who were harmed, injured, or killed during the SC flood. South Carolina Emergency Management Department (SCEMD) develops Prepared using sagej.cls Karami et al. 7 Table 4. Total Frequency of Topics Topic Victims Damage and Costs Drinking Water Insurance Homelessness Road Damage Percentage Topic Percentage 18.75% 15.62% 9.37% 9.37% 9.37% 9.37% Roof Damage Bridge Damage Flood Report Power Lost Animal 9.37% 6.25% 6.25% 4.68% 1.6% s c i p o T f o r e b m u N 8 7 6 5 4 3 2 1 2 3 4 5 6 7 8 9 10 11 12 13 Date Figure 3. Number of Negative Topics Per Day Table 5. Negative Topics from 10/03/2015 to 10/15/2015 5 1 / 3 0 / 0 1 : 1 y a D 0 0 1 0 1 1 0 0 0 0 0 5 1 / 4 0 / 0 1 : 2 y a D 1 0 1 0 1 0 0 1 0 0 1 5 1 / 5 0 / 0 1 : 3 y a D 0 1 1 1 0 1 0 0 1 1 1 5 1 / 6 0 / 0 1 : 4 y a D 0 0 1 1 1 1 1 0 1 1 1 5 1 / 7 0 / 0 1 : 5 y a D 0 0 1 1 1 1 1 0 1 1 1 5 1 / 8 0 / 0 1 : 6 y a D 0 1 0 1 0 1 1 1 1 1 1 5 1 / 9 0 / 0 1 : 7 y a D 0 1 1 1 0 1 0 0 1 1 1 5 1 / 0 1 / 0 1 : 8 y a D 0 0 1 1 0 0 0 1 0 1 1 5 1 / 1 1 / 0 1 : 9 y a D 0 0 1 0 0 0 1 0 0 0 1 5 1 / 2 1 / 0 1 : 0 1 y a D 0 0 0 0 0 0 1 0 1 0 1 5 1 / 3 1 / 0 1 : 1 1 y a D 0 0 0 0 1 0 1 0 0 0 1 5 1 / 4 1 / 0 1 : 2 1 y a D 0 1 1 0 0 0 0 0 0 0 1 5 1 / 5 1 / 0 1 : 3 1 y a D 0 0 1 0 0 0 0 0 0 0 1 Animal Bridge Damage Damage and Costs Drinking Water Flood Report Homelessness Insurance Power Loss Road Damage Roof Damage Victims and coordinates the South Carlina emergency management program for effective response to disasters. SCEMD reported that 19 people were killed and more than 1,500 were rescued from water [9]. "Damage & Costs" is the next high frequent topic that describes financial damage. SCEMD reported that 28,162 people received $2.2 billion aid through FEMA (Federal Emergency Management Agency) Prepared using sagej.cls 8 Journal of Information Science XX(X) and SCEMD. In addition, more than 3000 collisions [9] and more than 73,000 damaged structures [8] were recorded during the SC flood. The next topic is "Drinking Water". During the 2015 SC flood, the drinking water system was collapsed in some area such as Columbia (South Carolina's capital city) [85] and thousands of SC residents did not have water for days [86]. In addition, boil water advisory was issued for some days in some parts of South Carolina [87]. With respect to "Insurance" topic, most SC residents did not have flood insurance in 2015 and FEMA allocated more than $89 million for individual assistance [88]. In addition, it was suggested to increase insurance penetration and accessibility in South Carolina [8]. The next topic is "Homelessness." Thousands of SC residents were displaced and hundreds of people were staying in shelters [86]. This topic covers two groups of people. First people who were forced to leave their home and the second people who did not have a permanent place to live [89]. This topic is an interesting one because SCEMD report did not mention this topic [9]. "Road", "Roof", and "Bridge" damages are the next three issues. South Carolina has the fourth largest state-owned highway system with 41,000 miles of road and 8,400 bridges in U.S.A [90]. More than 500 roads and bridges were damaged during the flood [9], and 8 out of the 19 deaths occurred on a flooded road [91]. The SC flood caused expensive roof damage. The estimates placed the repair cost close to $137 million dollars [92, 93, 8]. Hundreds of bridges were damaged and closed in October 2015 [9]. "Flood Report" topic shows the reports and warnings that were retweeted (rt). 41 warning were issued during the flood, and different contents such as images from the floods, local storm reports, and areas of major flooding were shared [91]. The next topic is "Power Loss". Thousands of people did not have power for some days during the flood [86]. Finally, "Animals" was the last and the least discussed topic in the negative tweets. This topic shows main public concerns for animals. During the 2015 SC flood, hundreds of pets were rescued [94] and some of them lost their homes [95]. Supporting animals was one of the topics mentioned in tweets on the second day. This is the second interesting topic that was not addressed in the SCEMD's report. On the other side, we saw that food was the only topic that was in the SCEMD's report but not in our analysis. More than 2 million meals were served [9] and it seems that this topic wasn't among main concerns during the flood. The findings show that this research helps situational awareness in some directions. The first one is providing a big picture of damages and public concerns. For example, detecting damage reports by our framework shows show the large size of damages because LDA identifies topics discussed by a large number of users. That big picture can aid the state and federal agencies to have a better-cost estimation and resource allocation. This study can give the agencies a list of priorities for each day. For example, we think that the considering and addressing the insurance concern in the first five days were an excellent strategy to calm the people without an immediate cost. Comparing to other studies, this study has several benefits. First, TwiSA is a fast, real-time, and cost effective framework. The second benefit is combining sentiment analysis and topic modeling methods. While other studies have used the two methods separately without a connection between them in SA analysis, this research provides a flexible framework that has a potential to embed other techniques such as utilizing deep learning for sentiment analysis and LDA. The next benefit is focusing on disagreeable or negative experiences, instead of all experiences. The third advantage is introducing new issues such as insurance in a disaster, which were not considered in other studies and confirmed by official reports. The next asset is to have a dynamic perspective exploring the disaster issues during a time frame. Prepared using sagej.cls Karami et al. 9 Accessing high quality and relevant real-time data during a natural disaster can increase safety and reduce damage and social effects [6]. Every user is a sensor and contributor in social media and can generate valuable and immediate real-time data to develop better situational awareness. However, social media users generate a huge amount of data that needs to be summarized to provide a big picture in a disastrous situation. The opinion survey is a traditional method to analyze public opinion; however, this expensive method should be implemented after natural disasters. In addition, a low number of people participate in the data collection and data analysis steps takes a considerable amount of time [96]. The growth of social media has provided a great opportunity to track public opinion. Big real-time social media data can help disaster managers to develop a better SA during a natural disaster. This research proposes an analytical framework to detect and track leading public concerns on social networks such as Twitter to provide a better picture of a disaster. TwiSA combines sentiment analysis and topic modeling to handle a hug number of tweets and to disclose negative public concerns. This paper found that "victims", "damages", "drinking water", "insurance", "flood report", "power loss", 'homelessness", and "animals" are the topics that were discussed in negative tweets during the flood. We also found two topics, "homelessness", and "animals", were not mentioned in the official reports after the flood. It seems that human and non-human damages, drinking water, and insurance were the most discussed topics during the SC flood. Even though TwiSA was applied to the 2015 SC flood twitter data, it is not limited to this context and can be applied to other natural disasters and emergency situations. This research shows that social media are valuable data sources to explore people concerns during a natural disaster. TwiSA can help disaster management teams to find public's concerns in the fastest way to develop a better real-time crisis management plan. The proposed framework can be used not only during natural disasters but also after natural disasters as a post-event methodology review capability (PERC) for future disaster risk reduction. This research has applications for policymakers and disaster risk management experts in developing a better strategy for analyzing social media contents and responding to it. It also helps social scientific research in developing Public Service Announcement (PSA) and unveiling public opinions [91]. Our future directions center on minimizing the impact of noises and misinformation, and analyzing positive and neutral tweets. A potential limitation of our approach is that LIWC tool doesn't usually detect emotions, misspellings, colloquialisms, foreign words, sarcasm, and abbreviations [97]. Another limitation is related to the tweets containing wrong or inaccurate information and spams [98]. LDA detects major topics, not every single of topics, in a corpus. Therefore, we assumed that the massive number of tweets in a disaster buries noises. While we believe that the noises don't have a significant impact on the results, we will utilize some approaches to reduce the possible effects of the noises. The first approach is removing retweets and the tweets containing URL to avoid spams. The second approach is detecting unrelated or inaccurate topics and then eliminating the tweets whose primary topic is among the irrelevant or inaccurate topics. The primary topic is the topic that has the highest probability for a tweet. The next approach is using bot detection tools such as Botometer [99] to remove social bots spreading misinformation. We believe that the future plan will address these limitations to provide higher quality data and new insights to SA. Prepared using sagej.cls 10 Journal of Information Science XX(X) Acknowledgements This research is supported in part by the University of South Carolina Office of the Vice President for Research through the 2015 SC Floods Research Initiative. The authors are grateful for this support and all opinions, findings, conclusions and recommendations in this article are those of the authors and do not necessarily reflect the views of the funding agency. References [1] Olanoff D. Twitter Monthly Active Users Crawl To 316M, Dorsey: "We Are Not Satisfied". https://techcrunch.com/2015/07/28/twitter-monthly-active-users-crawl-to-316m-up-just-15-year-over-year/, 2015. Accessed: 2017-28-02. [2] Mejova Y, Weber I and Macy MW. Twitter: a digital socioscope. Cambridge University Press, 2015. [3] Paul MJ and Dredze M. You are what you tweet: Analyzing twitter for public health. ICWSM 2011; 20: 265 -- 272. [4] Sarter NB and Woods DD. Situation awareness: A critical but ill-defined phenomenon. The International Journal of Aviation Psychology 1991; 1(1): 45 -- 57. [5] Castillo C. Big Crisis Data. Cambridge University Press, 2016. [6] Kitchin R. The real-time city? big data and smart urbanism. GeoJournal 2014; 79(1): 1 -- 14. [7] Madey G, Barab´asi AL, Chawla N et al. Enhanced situational awareness: Application of dddas concepts to emergency and disaster management. Computational Science -- ICCS 2007 2007; : 1090 -- 1097. [8] ZURICH. What can be learned from the columbia and charleston floods 2015? https://www.zurich.com/_/media/dbe/corporate/docs/corporate-responsibility/risk-nexus-south-carolina-floods-2015.pdf?la=en&hash=CACE692203311CC2D883A5B0AA7B4954B9CA4742, 2015. Accessed: 2017-28-02. [9] Emergency Management Department (SCEMD). October, 2015 statewide flooding incident, 2016. https://www.scemd.org/news/october-2015-flooding-incident/, Accessed: 2017-28-02. [10] Vieweg S, Hughes AL, Starbird K et al. Microblogging during two natural hazards events: what twitter may contribute to situational awareness. In Proceedings of the SIGCHI conference on human factors in computing systems. ACM, pp. 1079 -- 1088. [11] Neppalli VK, Caragea C, Squicciarini A et al. Sentiment analysis during hurricane sandy in emergency response. International Journal of Disaster Risk Reduction 2017; 21: 213 -- 222. [12] Callaghan CW. Disaster management, crowdsourced r&d and probabilistic innovation theory: Toward real time disaster response capability. International journal of disaster risk reduction 2016; 17: 238 -- 250. Prepared using sagej.cls Karami et al. 11 [13] Bollen J, Mao H and Zeng X. Twitter mood predicts the stock market. Journal of Computational Science 2011; 2(1): 1 -- 8. [14] Collins M and Karami A. Social media analysis for organizations: Us northeastern public and state libraries case study. In Proceedings of the Southern Association for Information Systems (SAIS). Atlanta, Georgia. [15] Karami A and Collins M. What do the us west coast public libraries post on twitter? Proceedings of the Association for Information Science and Technology 2018; 55(1): 216 -- 225. [16] Kordzadeh N. Exploring the use of twitter by leading medical centers in the united states. In Proceedings of the 52nd Hawaii International Conference on System Sciences. [17] Kordzadeh N and Chen S. Investigating the use of twitter by three major us medical centers 2018; . [18] Tumasjan A, Sprenger TO, Sandner PG et al. Predicting elections with twitter: What 140 characters reveal about political sentiment. In ICWSM 10. [19] Karami A, Bennett LS and He X. Mining public opinion about economic issues: Twitter and the us presidential election. International Journal of Strategic Decision Sciences (IJSDS) 2018; 9(1): 18 -- 28. [20] Alperin JP, Dumas C, Karami A et al. Politicians & the public: The analysis of political communication in social media. Proceedings of the Association for Information Science and Technology 2018; 55(1): 646 -- 649. [21] Kitzie VL, Mohammadi E and Karami A. life never matters in the democrats mind: Examining strategies of retweeted social bots during a mass shooting event. Proceedings of the Association for Information Science and Technology 2018; 55(1): 254 -- 263. [22] Najafabadi MM and Domanski RJ. Hacktivism and distributed hashtag spoiling on twitter: Tales of the# irantalks. First Monday 2018; 23(4). [23] Karami A and Aida E. Political popularity analysis in social media. In Proceedings of the iConference. Washington, DC. [24] Szomszor M, Kostkova P and De Quincey E. # swineflu: Twitter predicts swine flu outbreak in 2009. In International Conference on Electronic Healthcare. Springer, pp. 18 -- 26. [25] Frank W, Karami A and Vanessa K. Characterizing diseases and disorders in gay users' tweets. In Proceedings of the Southern Association for Information Systems (SAIS). Atlanta, Georgia. [26] Karami A, Dahl AA, Turner-McGrievy G et al. Characterizing diabetes, diet, exercise, and obesity comments on twitter. International Journal of Information Management 2018; 38(1): 1 -- 6. [27] Karami A, Webb F and Kitzie VL. Characterizing transgender health issues in twitter. Proceedings of the Association for Information Science and Technology 2018; 55(1): 207 -- 215. Prepared using sagej.cls 12 Journal of Information Science XX(X) [28] Shaw Jr G and Karami A. Computational content analysis of negative tweets for obesity, diet, diabetes, and exercise. Proceedings of the Association for Information Science and Technology 2017; 54(1): 357 -- 365. [29] Shaw G and Karami A. An exploratory study of (#) exercise in the twittersphere. In Proceedings of the iConference. Washington, DC. [30] Abel F, Hauff C, Houben GJ et al. Twitcident: fighting fire with information from social web streams. In Proceedings of the 21st International Conference on World Wide Web. ACM, pp. 305 -- 308. [31] Sinnappan S, Farrell C and Stewart E. Priceless tweets! a study on twitter messages posted during crisis: Black saturday. ACIS 2010 Proceedings 2010; 39. [32] Avvenuti M, Cresci S, Marchetti A et al. Ears (earthquake alert and report system): a real time decision support system for earthquake crisis management. In Proceedings of the 20th ACM SIGKDD international conference on knowledge discovery and data mining. ACM, pp. 1749 -- 1758. [33] Sakaki T, Okazaki M and Matsuo Y. Tweet analysis for real-time event detection and earthquake IEEE Transactions on Knowledge and Data Engineering 2013; reporting system development. 25(4): 919 -- 931. [34] Earle PS, Bowden DC and Guy M. Twitter earthquake detection: earthquake monitoring in a social world. Annals of Geophysics 2012; 54(6). [35] Sakaki T, Okazaki M and Matsuo Y. Earthquake shakes twitter users: real-time event detection by social sensors. In Proceedings of the 19th international conference on World wide web. ACM, pp. 851 -- 860. [36] Robinson B, Power R and Cameron M. A sensitive twitter earthquake detector. In Proceedings of the 22nd International Conference on World Wide Web. ACM, pp. 999 -- 1002. [37] Miyabe M, Miura A and Aramaki E. Use trend analysis of twitter after the great east japan In Proceedings of the ACM 2012 conference on Computer Supported Cooperative earthquake. Work Companion. ACM, pp. 175 -- 178. [38] Doan S, Vo BKH and Collier N. An analysis of twitter messages in the 2011 tohoku earthquake. In International Conference on Electronic Healthcare. Springer, pp. 58 -- 66. [39] Oh O, Kwon KH and Rao HR. An exploration of social media in extreme events: Rumor theory and twitter during the haiti earthquake 2010. In International Conference on Information Systems. [40] Hughes AL, St Denis LA, Palen L et al. Online public communications by police & fire services during the 2012 hurricane sandy. In Proceedings of the 32nd annual ACM conference on Human factors in computing systems. ACM, pp. 1505 -- 1514. [41] Gupta A, Lamba H, Kumaraguru P et al. Faking sandy: characterizing and identifying fake images on twitter during hurricane sandy. In Proceedings of the 22nd international conference on World Wide Web. ACM, pp. 729 -- 736. Prepared using sagej.cls Karami et al. 13 [42] Takahashi B, Tandoc EC and Carmichael C. Communicating on twitter during a disaster: An analysis of tweets during typhoon haiyan in the philippines. Computers in Human Behavior 2015; 50: 392 -- 398. [43] Sreenivasan ND, Lee CS and Goh DHL. Tweet me home: Exploring information use on twitter In International Conference on Online Communities and Social Computing. in crisis situations. Springer, pp. 120 -- 129. [44] Palen L, Starbird K, Vieweg S et al. Twitter-based information distribution during the 2009 red river valley flood threat. Bulletin of the American Society for Information Science and Technology 2010; 36(5): 13 -- 17. [45] de Albuquerque JP, Herfort B, Brenning A et al. A geographic approach for combining social media and authoritative data towards identifying useful information for disaster management. International Journal of Geographical Information Science 2015; 29(4): 667 -- 689. [46] Ashktorab Z, Brown C, Nandi M et al. Tweedr: Mining twitter to inform disaster response. In Proceeding of the 11th International Conference on Information Systems for Crisis Response and Management (ISCRAM). ACM, pp. 77 -- 80. [47] Dashti S, Palen L, Heris MP et al. Supporting disaster reconnaissance with social media data: a design-oriented case study of the 2013 colorado floods. In Proceedings of the 11th International ISCRAM Conference. pp. 18 -- 21. [48] Herfort B, Schelhorn SJ, Albuquerque JPd et al. Does the spatiotemporal distribution of tweets match the spatiotemporal distribution of flood phenomena? a study about the river elbe flood in june 2013. In International Conference on Information Systems for Crisis Response and Management, 11. The Pennsylvania State University. [49] Murthy D and Longwell SA. Twitter and disasters: The uses of twitter during the 2010 pakistan floods. Information, Communication & Society 2013; 16(6): 837 -- 855. [50] Shaw F, Burgess J, Crawford K et al. Sharing news, making sense, saying thanks. Australian Journal of Communication 2013; 40(1): 23. [51] Kongthon A, Haruechaiyasak C, Pailai J et al. The role of twitter during a natural disaster: In 2012 Proceedings of PICMET'12: Technology Management Case study of 2011 thai flood. for Emerging Technologies. IEEE, pp. 2227 -- 2232. [52] Twitter. https://dev.twitter.com/overview/documentation, 2017. Accessed: 2017-28-02. [53] GNIP. https://gnip.com/, 2017. Accessed: 2017-28-02. [54] Taboada M, Brooke J, Tofiloski M et al. Lexicon-based methods for sentiment analysis. Computational linguistics 2011; 37(2): 267 -- 307. Prepared using sagej.cls 14 Journal of Information Science XX(X) [55] Khan AZ, Atique M and Thakare V. Combining lexicon-based and learning-based methods International Journal of Electronics, Communication and Soft for twitter sentiment analysis. Computing Science & Engineering (IJECSCSE) 2015; : 89. [56] Medhat W, Hassan A and Korashy H. Sentiment analysis algorithms and applications: A survey. Ain Shams Engineering Journal 2014; 5(4): 1093 -- 1113. [57] Linguistic Inquiry and Word Count (LIWC). http://liwc.wpengine.com/, 2017. Accessed: 2017-28-02. [58] Karami A and Zhou L. Improving static sms spam detection by using new content-based features. Proceedings of the 20th Americas Conference on Information Systems (AMCIS) Savannah, GA 2014; . [59] Karami A and Zhou L. Exploiting latent content based features for the detection of static sms spams. Proceedings of the 77th annual meeting of the association for information science and technology (ASIST) Seattle, WA 2014; . [60] Karami A and Zhou B. Online review spam detection by new linguistic features. Proceedings of the iConference Irvine, CA 2015; . [61] Franklin E. Some theoretical considerations in off-the-shelf text analysis software. In Proceedings of the Student Research Workshop associated with RANLP. pp. 8 -- 15. [62] Golder SA and Macy MW. Diurnal and seasonal mood vary with work, sleep, and daylength across diverse cultures. Science 2011; 333(6051): 1878 -- 1881. [63] Gonc¸alves P, Ara´ujo M, Benevenuto F et al. Comparing and combining sentiment analysis methods. In Proceedings of the first ACM conference on Online social networks. ACM, pp. 27 -- 38. [64] Nolen-Hoeksema S and Morrow J. A prospective study of depression and posttraumatic stress symptoms after a natural disaster: the 1989 loma prieta earthquake. Journal of personality and social psychology 1991; 61(1): 115. [65] Yin D, Bond SD and Zhang H. Anxious or angry? effects of discrete emotions on the perceived helpfulness of online reviews. MIS Quarterly 2014; 38(2): 539 -- 560. [66] Zhang D, Luo T and Wang D. Learning from lda using deep neural networks. In Natural Language Understanding and Intelligent Applications. Springer, 2016. pp. 657 -- 664. [67] Mohammadi M, Al-Fuqaha A, Sorour S et al. Deep learning for iot big data and streaming analytics: A survey. IEEE Communications Surveys & Tutorials 2018; . [68] Zhao W. Research on the deep learning of the small sample data based on transfer learning. In AIP Conference Proceedings, volume 1864. AIP Publishing, p. 020018. [69] Chilimbi TM, Suzue Y, Apacible J et al. Project adam: Building an efficient and scalable deep learning training system. In OSDI, volume 14. pp. 571 -- 582. Prepared using sagej.cls Karami et al. 15 [70] Erhan D, Bengio Y, Courville A et al. Why does unsupervised pre-training help deep learning? Journal of Machine Learning Research 2010; 11(Feb): 625 -- 660. [71] Severyn A and Moschitti A. Twitter sentiment analysis with deep convolutional neural networks. In Proceedings of the 38th International ACM SIGIR Conference on Research and Development in Information Retrieval. ACM, pp. 959 -- 962. [72] Mahmud M, Kaiser MS, Hussain A et al. Applications of deep learning and reinforcement learning to biological data. IEEE transactions on neural networks and learning systems 2018; 29(6): 2063 -- 2079. [73] Blei DM, Ng AY and Jordan MI. Latent dirichlet allocation. Journal of machine Learning research 2003; 3: 993 -- 1022. [74] Mcauliffe JD and Blei DM. Supervised topic models. In Proceedings of the Advances in neural information processing systems. pp. 121 -- 128. [75] Hong L and Davison BD. Empirical study of topic modeling in twitter. In Proceedings of the first workshop on social media analytics. ACM, pp. 80 -- 88. [76] Karami A and Gangopadhyay A. Fftm: A fuzzy feature transformation method for medical documents. Proceedings of BioNLP Baltimore, MD 2014; . [77] Karami A, Gangopadhyay A, Zhou B et al. A fuzzy approach model for uncovering hidden latent semantic structure in medical text collections. Proceedings of the iConference Irvine, CA 2015; . [78] Lu Y, Mei Q and Zhai C. Investigating task performance of probabilistic topic models: an empirical study of plsa and lda. Information Retrieval 2011; 14(2): 178 -- 203. [79] Karami A and Pendergraft NM. Computational analysis of insurance complaints: Geico case study. International Conference on Social Computing, Behavioral-Cultural Modeling, & Prediction and Behavior Representation in Modeling and Simulation Washington DC 2018; . [80] Karami A. Fuzzy Topic Modeling for Medical Corpora. PhD Thesis, University of Maryland, Baltimore County, 2015. [81] Karami A, Gangopadhyay A, Zhou B et al. Fuzzy approach topic discovery in health and medical corpora. International Journal of Fuzzy Systems 2018; 20(4): 1334 -- 1345. [82] Karami A, Gangopadhyay A, Zhou B et al. Flatm: A fuzzy logic approach topic model for medical documents. In 2015 Annual Meeting of the North American Fuzzy Information Processing Society (NAFIPS). IEEE. [83] Mallet. http://mallet.cs.umass.edu/topics.php, 2017. Accessed: 2017-28-02. [84] Steyvers M and Griffiths T. Probabilistic topic models. Handbook of latent semantic analysis ; 427(7): 424 -- 440. Prepared using sagej.cls 16 Journal of Information Science XX(X) [85] JournalStar. http://www.pjstar.com/article/20151008/NEWS/151009377, 2015. Accessed: 2017-28-02. [86] Senna A and Collins J. South Carolina flood: Thousands without running water. http://www.thestate.com/news/nation-world/national/article37801893.html, 2015. Accessed: 2017-28-02. [87] Wallace A. Curfew, boil water advisory issued as flooding continues. http://www.coladaily.com/2015/10/04/officials-issue-warnings-floods-sweep-columbia-area/, 2015. Accessed: 2017-28-02. [88] PRNewswire. Massive flooding in south carolina; many consumers lack flood insurance, 2015. http://www.prnewswire.com/news-releases/massive-flooding-in-south-carolina-many-consumers-lack-flood-insurance-300154495.html, Accessed: 2017-28-02. [89] Ohnesorge S. Homeless man loses "home" in SC flooding. http://www.wbtv.com/story/30203344/homeless-man-loses-home-in-sc-flooding, 2015. Accessed: 2017-28-02. [90] 2015 DOT Annual Report. http://dc.statelibrary.sc.gov/bitstream/handle/10827/21838/DOT_Annual_Report_2015-2016.pdf?sequence=1&isAllowed=y, 2016. Accessed: 2017-28-02. [91] US Department of Commerce. The historic south carolina floods of october 15, 2015, 2015. http://www.weather.gov/media/publications/assessments/SCFlooding_072216_Signed_Final.pdf, Accessed: 2017-28-02. [92] GreenvileOnline. Storm system brings property damage, flooding, record rains, 2015. http://www.greenvilleonline.com/story/news/local/2015/06/03/storm-system-brings-property-damage-flooding-record-rains/28403225/, Accessed: 2017-28-02. [93] John McDermott. S.C. insurers brace for surge of flood claims. http://www.postandcourier.com/business/s-c-insurers-brace-for-surge-of-flood-claims/article_d67b6317-2145-5063-ba1b-61850ded7c0e.html, 2015. Accessed: 2017-28-02. [94] Ferris R. South Carolina's rain and floods, by the numbers. http://www.cnbc.com/2015/10/08/south-carolinas-rain-and-floods-by-the-numbers.html, 2015. Accessed: 2017-28-02. [95] Lu F. Dogs left homeless after S.C. flooding arrive in Mass. in search of new owners. http://www.masslive.com/news/index.ssf/2015/10/dogs_left_homeless_after_sc_fl.html, 2015. Accessed: 2017-28-02. [96] Urcan I. Flood hazards perception: The result of an opinion survey made in the little towns from lower aries corridor. Journal of Catastrophe 2012; 11: 202 -- 210. [97] Pennebaker JW, Boyd RL, Jordan K et al. The development and psychometric properties of liwc2015. Technical report, 2015. Prepared using sagej.cls Karami et al. 17 [98] Najafabadi MM. A research agenda for distributed hashtag spoiling: Tails of a survived trending In Proceedings of the 18th Annual International Conference on Digital Government hashtag. Research. ACM, pp. 21 -- 29. [99] Ferrara E, Varol O, Davis C et al. The rise of social bots. Communications of the ACM 2016; 59(7): 96 -- 104. Prepared using sagej.cls
1702.02040
1
1702
2017-02-07T14:38:55
Vulnerability of D2D Communications from Interconnected Social Networks
[ "cs.SI" ]
In this paper, we study how rumors in Online Social Networks (OSNs) may impact the performance of device-to-device (D2D) communication. As D2D is a new technology, people may choose not to use it when believed in rumors of its negative impacts. Thus, the cellular network with underlaying D2D is vulnerable to OSNs as rumors in OSNs may decrement the throughput of the cellular network in popular content delivery scenarios. To analyze the vulnerability, we introduce the problem of finding the most critical nodes in the OSN such that the throughput of a content delivery scenario is minimized when a rumor starts from those nodes. We then propose an efficient solution to the critical nodes detection problem. The severity of such vulnerability is supported by extensive experiments in various simulation settings, from which we observe up to $40\%$ reduction in network throughput.
cs.SI
cs
Vulnerability of D2D Communications from Interconnected Social Networks Tianyi Pan1, Md Abdul Alim1, Xiang Li1, and My T. Thai1 1University of Florida, Gainesville, FL, USA {tianyi,alim,xixiang,mythai}@cise.ufl.edu July 1, 2021 Abstract In this paper, we study how rumors in Online Social Networks (OSNs) may impact the perfor- mance of device-to-device (D2D) communication. As D2D is a new technology, people may choose not to use it when believed in rumors of its negative impacts. Thus, the cellular network with underlaying D2D is vulnerable to OSNs as rumors in OSNs may decrement the throughput of the cellular network in popular content delivery scenarios. To analyze the vulnerability, we introduce the problem of finding the most critical nodes in the OSN such that the throughput of a content delivery scenario is minimized when a rumor starts from those nodes. We then propose an efficient solution to the critical nodes detection problem. The severity of such vulnerability is supported by extensive experiments in various simulation settings, from which we observe up to 40% reduction in network throughput. 7 1 0 2 b e F 7 ] I S . s c [ 1 v 0 4 0 2 0 . 2 0 7 1 : v i X r a 1 Introduction D2D communication is a promising approach to cope with the rapidly increasing demand of mobile data [1], in which user equipments (UEs) directly communicate with each other while bypassing the cellular network's base stations (BSs). For the cellular network, utilizing D2D communication can therefore offload its mobile data traffic and significantly boost the overall performance [2 -- 5]. However, as a new technology, D2D communication will be likely to face doubts from various perspectives, such as efficiency, safety, etc. When users lacking the knowledge of D2D, exaggerated disadvantages of D2D can also be generated and spread as rumors, either randomly by some normal users, or intentionally by malicious individuals. With OSN as the medium, rumors can propagate conveniently and affect a large portion of the users in the network [6 -- 8] and cause the users to opt-out of D2D. When a requester chooses not to use D2D, its request has to be served by a cellular link; when a relay device disables D2D, some requesters in its proximity may not be served via D2D anymore. Both situations can potentially increase the burden of the BS and the overall throughput can degrade. Therefore, the cellular network is vulnerable to the rumors spreading in its interconnected OSN. An example is depicted in Fig. 1. (a) D2D link between devices 1, 2 helps offloading traffic from the BS. (b) Throughput drops when device 1 opt-out of D2D due to rumor. Figure 1: Rumor Impacts D2D Performance To assess the vulnerability of the cellular network from an interdependent OSN, we propose the TMIN (Throughput Minimization in INterdependent D2D/OSN) problem that asks for a set of k nodes in the OSN, such that when a rumor starts from those nodes, the throughput in the cellular network for a popular content delivery scenario is minimized. In order to consider the vulnerability in the worst case, we assume the rumor starts early and all OSN users believed in the rumor will disable D2D on their devices before the content delivery starts. The throughput of the content delivery scenario in the cellular network is then calculated based on the (possibly) reduced number of D2D devices. The main challenge of TMIN is that the data transmission problem in the cellular network and the information propagation problem in the OSN must be jointly considered in order to accurately depict the impact or rumors to D2D communication. With high complexity from both problems, it is difficult to optimally solve TMIN. To cope with the challenges, we propose Rumor the Critical Framework (RCF) that connects the two networks by first evaluating the criticality of UEs in content delivery and mapping the values to the OSN, and then efficiently solve the Influence Maximization (IM) problem in the OSN, considering node criticality. In summary, our contributions are as follows: • We analyze the vulnerability of a cellular network with underlaying D2D from an interdepen- 1 CellularSocialabc123CellularSocial123abc dent OSN, by solving the problem TMIN of finding the most critical nodes in the OSN to the throughput in the cellular network. • We propose the algorithm RCF that can efficiently make near optimal decisions for TMIN. • We experimentally evaluate the vulnerability in various simulation settings with realistic cellular network parameters and real-world OSN data. Related Work. Recently, the use of D2D communication to improve the spectrum efficiency and system capacity has received much interest [2 -- 5, 9, 11 -- 25]. Towards this direction, previous works studied resource allocation [3,19 -- 22], interference management [11 -- 13,15], power control [9,14,18] and base station scheduling [25]. In order to construct stable D2D transmission links, the social aspect can be utilized. Social trust and social reciprocity have been leveraged in [23] to enhance cooperative D2D communication based on a coalitional game. In [24], encounter history of the devices as well as their social relations are exploited in order to deploy a reliable D2D communication mechanism. Social communities [26] were also utilized [27] to facilitate finding stable D2D links. However, none of the existing works can capture how the information diffusion phenomenon in OSNs affects different performance metrics of D2D communication underlaid cellular networks. In OSNs, the NP-Complete IM problem [28] is widely studied. Since the seminal work by Kempe et al. [28], a plethora of works for IM have been proposed [?, ?, ?, 29 -- 40]. The state-of-the-art works [?, ?, 37 -- 40] follow the RIS approach proposed in [37]. They guarantee the (1 − 1 ratio with a time complexity near linear to the network size. The existing works usually focus on the OSNs, without considering how the information can influence other networks, like D2D networks, that are interconnected with the OSNs. e − ) approximation Organization. The rest of the paper is organized as follows. In Sect. 2, we describe the cellular network, the OSN, their dynamics, interactions and vulnerability. We also formally define the TMIN problem. We propose our solution RCF to TMIN in Sect. 3. The experiment results are illustrated in Sect. 4. We conclude the paper in Sect. 5. 2 System Model In this section, we present the system model of interest and introduce the two components, the cellular network and the OSN respectively. Then we formally define the TMIN problem. 2.1 The Cellular Network We study a cellular system as illustrated in Fig. 2. It has a single BS B and a set D of UEs. We denote the cellular network as Gc = (V c, Ec), where V c = D ∪ {B} and Ec denotes all cellular/D2D links. A subset of UEs V d ⊆ D enables D2D. Denote Gd = (V d, Ed) as the network induced in Gc by V d. A link (i, j) ∈ Ed exists if and only if UEs i, j ∈ V d are within D2D communication range. A subset R ⊆ D of UEs request the same content. R = Rc ∪ Rd where Rc = R\V d and Rd = R ∩ V d. As a UE in Rc disables D2D, its request can only be served by cellular links. Instead, a UE in Rd can have its request fulfilled either by cellular or D2D links. The set of UEs V r = V d\Rd does not request the data, but are able to be relay devices for UEs in Rd. For a node i, denote N−(i), N +(i) as the set of incoming/outgoing links of i, respectively. 2 Figure 2: The Cellular Network 2.1.1 Cellular Resources In this paper, we consider the resource sharing model discussed in [3, 5, 25]. In the model, the D2D and cellular links use disjoint portion of the licensed band. Denote the total bandwidth of the BS as W . If a resource allocation scheme allocates W c of the band to cellular links, the bandwidth for D2D links is then W − W c. Therefore, interference only exists among D2D links. Additionally, there is no further division in the frequency domain, so that cellular/D2D links will use the full bandwidth W c/W d. 2.1.2 Data Rates Based on the resource sharing model, a cellular link (B, i) receives no interference from D2D links and uses the full bandwidth. We can express its data rate r(B, i) under distance-dependent path loss and multipath Rayleigh fading as in (1), where γB,i is the Signal to Noise Ratio (SNR) for (B, i). r(B, i) = W c log2(1 + γ(B, i)) γB,i = pBd−α Bi m02 N0 (1) (2) In γB,i, pB is the transmit power of the BS; dBi is the distance between B, i; α is the path loss exponent; m0 is the fading component and N0 is the power of the receiver noise, which is assumed to be the additive white Gaussian noise. For a D2D link (j, k), we must include interference from other D2D links when calculating data rate r(j, k). Denote L as the set of D2D links that transmit at the same time with (j, k), we can calculate r(j, k) using (3). 3 𝑹𝑽𝒅𝑩𝑺 r(j, k) = W d log2(1 + γ(j, k)) jk m02 pjd−α γ(j, k) = (cid:80) (j(cid:48),k(cid:48))∈L pj(cid:48)d−α j(cid:48)km02 + N0 (3) (4) γ(j, k) is the Signal to Interference and Noise Ratio (SINR) and pj, pj(cid:48) are the transmit powers for UEs j, j(cid:48) respectively. The model can be extended to handle multiples BSs by adding intercell interference to the de- nominator part of (2) and (4). We model device mobility (when necessary) as multiple snapshots of static cellular networks for popular content delivery scenarios, since such scenarios usually happen at locations where devices have limited mobility (stadium, shopping mall) or the mobility follows certain routine (office, school). 2.2 The Online Social Network We abstract the OSN to be a weighted directed graph Gs with a node set V s and a directed link set Es, where a node v ∈ V s represents a user. A link (u, v) ∈ Es exists if and only if node v follows node u in the OSN. Also, each (u, v) is associated with a weight p(u, v) ∈ [0, 1] for information propagation. 2.2.1 Information Propagation To characterize how rumor propagates in the OSN, we will focus on the Independent Cascading (IC) model [28] in this paper. However, our results can be easily extended to the Linear Threshold (LT) model. In the IC Model, initially no nodes believe the rumor, we term this as the unactivated status. Given a seed set S, the rumor propagates in rounds. In round 0, only the nodes v ∈ S are activated (believed in the rumor). In round t ≥ 1, all nodes activated at round t − 1 will try to activate their neighbors. An activated node u will remain activated. It has probability p(u, v) to activate each unactivated neighbor v at the next round and it cannot activate any neighbors afterwards. The process stops when no more nodes can be activated. Denote I(S) as the expected number of nodes activated by the rumor with S as the seed set, where the expectation is taken over all p(u, v). We call I(S) as the influence spread of seed set S. When a problem considers differentiated gain of influencing the nodes, we denote the expected gain over all influenced nodes by S as Ic(S). 2.2.2 Interconnection between OSN and the Cellular Network The owners of the UEs D in the cellular network may be users in an OSN, as illustrated in Figure 1. As our focus is on the impact of OSNs to D2D communication, we construct a link evi only if a UE i ∈ V d has a corresponding user v ∈ V s. The collection of all such edges is denoted as Eds. We assume that each UE can be related to at most one OSN user and each OSN user owns at most one UE. Otherwise, dummy nodes can be used to recover the one-to-one correspondence. If evi ∈ Eds and i ∈ V d, when v believed in the rumor, UE i will no longer be in V d and cannot be included in any D2D links. Definition 1 (TMIN). Consider a cellular system with BS B, set of devices D, set of content requesters R ⊂ D and the cellular network Gc = (V c, Ec). Also, consider the OSN Gs = (V s, Es) and the correspondence among devices in V d and users in V s depicted by the edge set Eds. The information 4 propagation is described using the IC model with probability puv for each (u, v) ∈ Es. TMIN asks for a seed set in Gs with size at most k to minimize the throughput T in Gc. Solving TMIN reveals the top-k nodes in the OSN that are critical to the cellular network. Also, comparing the throughput in a scenario that is not impacted by rumors and the one solved by TMIN helps characterizing the degree of damage that rumors can cast to the cellular network. 3 Solution to TMIN In this section, we describe our solution RCF to TMIN by first presenting its overview and then introduce its two subroutines in detail. 3.1 The Overview Intuitively, the goal for TMIN is to find the most critical nodes in the OSN as seed nodes for the rumor, in order to impact the cellular network throughput the most. However, the OSN alone contains no information about the cellular network. Therefore, we must utilize the cellular network to provide information to the OSN and guide its critical nodes selection. In our solution framework RCF, we first calculate the criticality of all UEs in the cellular network using Alg. 2, based on the solutions for a throughput minimization problem defined in the cellular network. Then, we cast the criticality values of the devices to their corresponding users in the OSN and introduce an efficient targeted IM algorithm (Alg. 3) to find the top-k critical nodes in the OSN. The framework RCF is described in Alg. 1, while the two subroutines, Alg. 2 and Alg. 3 are discussed in Sect. 3.2 and 3.3, respectively. Algorithm 1 RCF Require: Cellular Network snapshots Gc = (V c, Ec), Social network Gs = (V s, Es),k Ensure: Seed set S ⊆ V s Calculate criticality values C = {cri,∀i ∈ vd} using Alg. 2 with budgets k, k + 1,··· ,V d and project them to corresponding nodes in V s. Solve the seed set ¯S by Alg. 3. return ¯S 3.2 Criticality Evaluation Scheme As the goal of the cellular network is to maximize its throughput, the criticality of the devices must be related to their contribution in throughput reduction. To characterize criticality, we start from the problem of finding the top-u critical nodes in the cellular network: those whose switching from D2D to cellular mode can minimize the maximum network throughput. With a fixed u, we are able to obtain the top-u critical nodes, yet with this piece of information alone we can only assign criticality value 1 for the top-u nodes and 0 for all the remaining. Such criticality values can be misleading as the values may change drastically with other u values. Therefore, it is necessary to consider the top-u critical nodes for various values of u and integrate the pieces of information, in order to have a complete view of how critical the devices are. In the following, we first propose an approach to find the top-u critical nodes in the cellular network, via solving a bi-level mixed integer linear program (MILP). Then, based on the solution of the MILP, we discuss Alg. 2, Node Criticality Evaluation (NCE), to determine node criticality. 5 Table 1: Summary of Notations for Section 3.2 Notation D Gc Gd I(i, j), I(e) c(i, j), ce Rc, Rd N +(i), N−(i) Gc(cid:48) El Ed(cid:48) Em fij, fe T ze W c W d k = (V c(cid:48) , Ec(cid:48) ), the modified cellular network Description Set of mobile devices Gc = (V c, Ec), the cellular network with all cellular/D2D links Gd = (V d, Ed), the D2D network Interference set of edge e = (i, j) ∈ Ec Capacity of edge e = (i, j) ∈ Ec Data content requesters in cellular/D2D mode Set of outgoing and incoming links of node i Gc(cid:48) The set of all cellular links in Gc(cid:48) The set of all D2D links in Gc(cid:48) Em = {eii ∈ V d}, the set of removable edges in Gc(cid:48) Flow rate on edge e = (i, j) ∈ Ec(cid:48) T = fvtB, the throughput of the network, where B denotes the BS and V t is a virtual sink node Binary variable indicates whether attack edge e (ze = 1) or not (ze = 0) Bandwidth allocated to cellular transmission Bandwidth allocated to D2D transmission Budget of the adversary 3.2.1 Find the Critical Nodes in the Cellular Network Under the system model discussed in 2.1, the cellular network can be modeled as a flow network. The capacity and flow of a cellular/D2D link is its maximum data rate and actual data rate, respectively. However, special care is required in the construction, for linearizing the calculation of data rate, and modeling devices switching from cellular to D2D mode, which will be discussed respectively as follows. Data Rate Estimation. In practice, calculating data rate often requires nonlinear formulas considering interference management and resource allocation. However, adding nonlinear constraints to a formulation can greatly increase its complexity. To avoid this, we describe an approach to estimate data rate. As the main purpose of studying TMIN is to demonstrate how cellular network throughput can be impacted by rumors in OSNs, the estimated data rates suffice. To estimate data rates, we first discuss the collision management for D2D and cellular links. Links sharing the same band cannot transmit concurrently if they are in the same access domain, in order to avoid collision. We denote such links as an Interference Set. The interference set for a link e = (i, j), I(e), can be defined as Ie = {(i(cid:48), j(cid:48))dii(cid:48) ≤ βd0} where β is a tunable parameter and d0 is the maximum D2D communication distance. Notice that the link e itself is also contained in I(e). With the interference sets for all links, we can obtain the set of links that are allowed to transmit at the same time, L(e), given one active link e. L(e) is constructed as follows. First we set L(e) = {e}. Then we iteratively select a link into L(e) if it causes the largest drop in data rate among links that are not in the interference sets of links in L(e). Assume each device has a fixed transmission power, the SINR for each D2D link can therefore be obtained using (4). Based on (3), the data rate is proportional to the bandwidth, which is a variable. For notation convenience, we calculate c(e) using (3), assuming unit bandwidth. Therefore, the maximum data rate of link e can be expressed by W d × c(e), recall 6 that W d is the bandwidth assigned to D2D communications. Similarly, we can use (1), (2) to obtain the maximum data rate for a cellular link e(cid:48), which is W c× c(e(cid:48)). The actual data rate f (e) is modeled as a linear variable upper bounded by the maximum data rate. Network Modification To create a flow network with a single source and a single sink, we introduce additional components, including a global sink node vt as well as the links (i, vt),∀i ∈ R and (vt, B). A link among those has infinite capacity and an empty interference set. Next, we model nodes switching from D2D mode to cellular mode. Two types of devices may switch their modes. The first type is the relay devices V r. When such devices turn to cellular mode, we can remove them from the network as they neither request any data nor contribute to D2D transmission. The second type is the receiver devices Rd. When such devices switch their modes, they still request data from the BS. So we must remove all D2D links associated with those devices, but keep their cellular links. To model a switch as a link removal, we split each node i ∈ V d into two nodes i−, i+. The incoming D2D links = {(i+, j−)(i, j) ∈ V d} as are connected to i− and all outgoing links are connected to i+. Denote Ed(cid:48) the set of all D2D links. For the cellular link (B, i), we replace it with (B, i−) if i ∈ V r and (B, i+) if i ∈ Rd. Let El = {(B, i)i ∈ vc\vd}∪{(B, i−)i ∈ V r}∪{(B, i+)i ∈ Rd} as the set of all cellular links. Nodes i−, i+ are connected by link ei = (i−, i+), which has an empty interference set and infinite capacity. Let Em = {eii ∈ V d}. Denote the modified graph as Gc(cid:48) = (V c(cid:48) ) where , Ec(cid:48) and V c(cid:48) = (V c\V d) ∪ {i−, i+i ∈ V d} ∪ {B, vt} Ec(cid:48) = El ∪ Ed(cid:48) ∪ Em ∪ {(vt, B)} ∪ {(i, vt)i ∈ R} We can easily verify that switching a node i from D2D to cellular in Gc is equivalent to removing link (i−, i+) in Gc(cid:48) . With the data rate model and the modified network Gc(cid:48) , we formulate the problem as a bi-level MILP P. (cid:88) s.t. i∈N−(j) e∈Em ze ∈ {0, 1},∀e ∈ Em T (z) = max fvtB P : min T (z) ze ≤ u s.t. (cid:88) fij − (cid:88) (cid:88) (cid:88) e(cid:48)∈I(e) k∈N +(j) fe(cid:48) W c × c(e(cid:48)) fe(cid:48) W d × c(e(cid:48)) fjk = 0,∀j ∈ V c(cid:48) ≤ 1,∀e ∈ El ≤ 1,∀e ∈ Ed(cid:48) e(cid:48)∈I(e) fe ≤ c(e)(1 − ze), ∀e ∈ Em W c + W d ≤ W fe ≥ 0, ∀e ∈ Ec(cid:48) W c, W d ≥ 0 (5) (6) (7) (8) (9) (10) (11) (12) (13) (14) (15) The objectives (5) (outer stage) and (8) (inner stage) guarantees the problem to be a minimization of the maximum throughput T . Constraint (6) restrict the solution to be top-u critical nodes. The binary 7 variable ze reaches 1 if link e is removed. Therefore, at most u links in Em, i.e. at most u devices in V d can be removed. Constraint (9) is the flow balance constraint. The traffic received by a device must be equal to what it transmits. Collision management in the cellular network are considered in (10) and (11), by which we ensure that only one link among all links in an interference set can transmit at any point of time. Also, since the traffic fe must be non-negative, (10) and (11) upperbound the traffic on any link by its data rate. Constraint (12) model the case that no flow can be assigned to a removed edge. Notice that we omit all links with infinite capacity for the capacity constraints. Constraint (13) limits the total bandwidth being used by cellular and D2D communications. As P cannot be solved directly due to its bi-level structure, we reformulate it as a single-level MILP P d by dualization and linearization techniques. The solution of P d is attainable via existing MILP solvers. Dualization of the Inner Stage. By dualization, we can transform the inner stage to a equivalent minimization problem, so that the original minimax bi-level formulation is equivalent to a minimization problem in only one stage. Denote p, qc, qd, r, l as the dual variables corresponds to constraints (9)-(13), respectively. The reformulated program after dualization is denoted as P d. P d : min W × l + c(e)(re − δe) (16) (17) (18) (19) (20) (21) (22) (23) (24) (25) (26) (27) (28) (29) (30) ∀e ∈ Em ∀e ∈ Em ∀e ∈ Em ∀i ∈ R ∀(i, j) ∈ El ∀(i, j) ∈ Ed(cid:48) ∀e ∈ Em ∀e ∈ El ∀e ∈ Ed(cid:48) (cid:88) (cid:88) e∈Em s.t. e∈Em ze ≤ u δe ≤ ze, δe ≤ re, δe ≥ re − (1 − ze), pB − pvt ≥ 1 pvt − pi ≥ 0, ≥ 0, qc e e∈I(i,j) c(i, j) qd e (cid:88) (cid:88) l − (cid:88) l − (cid:88) pj − pi + pj − pi + ≥ 0, e∈I(i,j) c(i, j) e∈El pj − pi + re ≥ 0,∀e = (i, j) ∈ Em e ≥ 0 qc e ≥ 0 qd ze ∈ {0, 1}, re ≥ 0, δe ≥ 0, e ≥ 0, qc e ≥ 0, qd l ≥ 0 e∈Ed(cid:48) 8 Linearization. The original dual objective contains a quadratic term (cid:80) (31) e∈Em c(e)re(1 − ze), which largely increases complexity. To achieve a linear formulation, we substitute reze with δe and add constraints (18) to (20). The equivalence after the step is proved in Lemma 1. Lemma 1. (18) to (20) guarantee δe = reze,∀e ∈ Em. Proof. First, we claim that the range of any re is [0, 1]. Based on the objective, both l and re should be minimized. As the only constraint that potentially requests an re value be higher than 0 is inequality (25), the value of re can be written as max{0, pi − pj} for e = (i, j) ∈ Em. Based on constraints (21) to (24), the largest value for any pi − pj is 1, otherwise the l value will be unnecessarily large and the solution is not optimal. Therefore, 0 ≤ re ≤ 1 for all e ∈ Em. By constraints (18) to (20), when ze = 0, δe = 0 = zere; when ze = 1, δe = re = zere(as re ≤ 1 = ze). As ze is binary, we have δe = zere in all cases. 3.2.2 The NCE Algorithm By the discussion at the beginning of Sect. 3.2, we can use the solutions of P d to support criticality evaluation as in Alg. 2. The program P d is solved under a set U = {u1, u2, ...uw} of budgets. Denote the solutions as z1,...,zw, we define the criticality of node i as (cid:88) cri = zp ei The definition of cri is aligned with the concept of being critical. A device i that appears in more P d solutions has higher criticality than another device j that contributes to less P d solutions. Intuitively, all users with no devices in the considered cellular network have 0 criticality. p=1,...,w Algorithm 2 Node criticality Evaluation(NCE) Require: Cellular network Gc = (V c, Ec), List of budgets U = {u1, u2, ..., uw} Ensure: C = {cri∀i ∈ V d} Initialize cri = 0,∀i ∈ V d for all up ∈ U do Solve P d with budget up in Gc. Denote the solution as z. cri+ = zei,∀i ∈ V d. end for return C We assume the availability of the full knowledge of the cellular network in this paper. In reality, a BS covering a business region may observe some frequently reappearing location patterns or mobility traces of the UEs in the form of snapshots, or static networks. Therefore, if an adversary wants to exploit the vulnerability of the interdependent cellular and social networks, s/he can calculate the criticality of the devices using Alg. 2 in all snapshots. However, how an adversary attacks the networks in reality is out of the scope of this paper, as our aim is to understand the vulnerability in the worst case. 3.3 Targeted IM Algorithm With Alg. 2, we can quantitatively evaluate the criticality of all nodes in the OSN. Due to the way the criticality values are assigned, when more nodes with large criticality values in the OSN are influenced, we can expect a more severe throughput reduction in the cellular network. Therefore, the problem of finding the top-k critical nodes in the OSN can be interpreted as the targeted-IM problem of finding k seed nodes to maximize the total criticality of all influenced nodes. In the following, we first propose an efficient Targeted-IM algorithm based on the reverse influence sampling (RIS) technique and then prove its guaranteed (1 − 1 e − ) approximation ratio and near-linear running time. 9 Table 2: Summary of Notations for Section 3.3 Notation Description Gs C Gs = (V s, Es), the social network C = {cri∀i ∈ V s}, criticality of all users Expected sum of criticality over all the nodes influenced by S The optimal seed set The collection of all RR sets. among R Ic(S) S∗ R degR(S) # of hyperedges incident to nodes in S v∈V s crv Estimator for Ic(S). ¯Ic(S) = degR(S) Precision parameters of Alg. 3 R Ω Ω =(cid:80) (cid:113) (cid:113) τ = Ω ¯Ic(S) , δ τ σ φ γ ¯S e )(ln(cid:0)n k (cid:1) + ln 2 ln( 2 δ ) (1 − 1 σ = φ = (1−1/e)σ+τ Stopping criterion for generating RR sets, γ = 2(φ2 + log 2 δ ) Seed set outputted by Alg. 3 δ )  Brief Review of the RIS Technique. RIS was first proposed in [37], which casts light on efficient It first samples Reverse Reachable (RR) sets and then apply a greedy maximum IM algorithms. coverage (MC) algorithm to obtain the seed set. An RR set R consists of the set of nodes that can reach an origin node o R in a sample graph G. With enough RR sets, one can estimate the influence each seed set can have to the whole network, by relating the seed set and the RR sets to a coverage instance, in which an RR set corresponds to an element and a node in the graph corresponds to a set. An element is covered by a set if and only if the node exists in the RR set. Approximately, the influence spread of a seed set is positively correlated to the number of covered RR sets over the total number of RR sets, greedily solving the MC can output a seed set with near-optimal influence spread. However, to establish an accurate estimation of influence spread of each seed set without exert too much burden to computation, the number of RR sets generated must be carefully selected. In our scenario, as the nodes are of different criticality values, the probability of starting a random Ω , proportional to its criticality values. Denote degR(S) as the number of RR RR set from node is crv sets in R covered by seed set S. To limit the number of RR sets, we set exponential check points during RR set generation. At each check point, we greedily solve the weighted MC problem [41] and examine if degR( ¯S) exceeds a threshold, where ¯S is the solution by the greedy MC. If so, we stop RR set generation and output ¯S as the seed set. The Targeted-IM algorithm is presented in Alg. 3. With an improved threshold, the time complexity of Targeted-IM is a constant smaller than the state-of-art target IM algorithm BCT [40]. In the following, we present the approximation ratio and time complexity of Alg. 3. For conciseness, the proof for Theorem 1 is placed in appendix. 10 Algorithm 3 Targeted-IM Require: Social network Gs = (V s, Es),with criticality values on nodes, seed set size k, Precision Ensure: Seed set S ⊆ V s parameters  > 0, δ ∈ (0, 1), γ Collection of RR sets R = ∅ NR = γ, N 0 while degR( ¯S) < γ do R to NR do for i = N 0 R = 1 Generate RR set R by BSA in [40]. R = R ∪ { R} end for ¯S = GreedyM C(R, k) N 0 R = NR, NR = 2NR end while return ¯S Theorem 1. With  > 0, 0 < δ < 1, the seed set ¯S calculated by Alg. 3 satisfies Ic( ¯S) ≥ (1− 1 with probability at least 1 − δ. Theorem 2. The expected running time of Alg. 3 is O(γEs). e−)Ic(S∗) The proof is a straightforward extension of the one in [40], and is omitted. 4 Experiments In this section, we evaluate how cellular network performance can be impacted when the critical nodes in the OSN propagates the rumor. In the following, we first discuss the setup for the experiments in Section 4.1. In Section 4.2, we measure the vulnerability of the cellular network. Then we consider how the actions of the users and the BS can reduce the vulnerability in Section 4.3 and 4.4, respectively. 4.1 Setup Cellular Network. As the real data sets are limited due to our requirements, we choose to use synthetic data for the cellular network. In a square 50m by 50m area, we generate 50 data requesters at random locations. Further, we select 30 of them to be in D2D mode and the other 20 remain in cellular mode. To enable D2D communication, we also generate 60 D2D relay devices at random locations within the area. All the wireless parameters are summarized in Table 3. OSN. To model information propagation in the OSN, we use real-world Facebook network topology from [42]. The Facebook data consists of 4039 users and 88234 social network interactions between the users [43]. The influence between a pair of users was assigned randomly from a uniform distribution. Interdependency. For the interconnection between the two networks, we consider two scenarios, namely a stadium scenario and a shopping mall scenario. In the stadium scenario, the owners of the devices are not very likely to be socially connected. In the shopping mall scenario, however, as the shoppers normally resides closer than the game goers, the owners of the devices are more likely to be connected in the OSN, compared with the stadium scenario. We use the following procedure to create the interconnections. For each D2D node i ∈ V d, we construct link evi between i and a uniformly randomly chosen user v ∈ V s from the OSN. Once evi is constructed, with probability p1, we uniformly randomly choose a neighbor i(cid:48) of i and a neighbor v(cid:48) 11 Table 3: Wireless Network Parameters Notation Cell dimension BS position Description 50 x 50 m2 Lower left corner Network bandwidth 0.1 MHz Channel Model Multipath Rayleigh fading Path Loss Exponent Noise spectral density BS transmit power D2D transmit power D2D distance 3 −174 dBm/Hz 100 W 10 W 15 m . With probability p2, we construct link e¯v¯i for a random neighbor ¯i of i(cid:48) of v and construct link ev(cid:48)i(cid:48) and a random neighbor ¯v of v(cid:48), when ev(cid:48)i(cid:48) is constructed. In order to differentiate the different level of social connections among users in the cell area, we apply higher p1, p2 values for the shopping mall scenario. In our experiments we have set p1 = 0.7 and p2 = 0.4 for the stadium scenario, and p1 = 0.9 and p2 = 0.6 for the shopping mall scenario. Algorithms. To illustrate the efficacy of our proposed method RCF, especially the criticalness evaluation scheme, we compare RCF with two approaches. The first approach uses degree centrality as criticalness values and runs the same targeted IM algorithm embedded in RCF to obtain the critical nodes in the OSN. The second approach, as a baseline, randomly assigns criticalness values to guide critical nodes selection in the OSN. 4.2 Vulnerability of the Cellular Network In this section, we study how vulnerable the cellular network is to rumors in the OSN, in terms of throughput reduction. Also, we demonstrate that social connectivity of the nodes in the cellular network can impact the vulnerability. Additionally, we explore another dimension of vulnerability: how much bandwidth is necessary to bring the throughput back to the original value. Figure 3: Throughput Reduction (a) Stadium Scenario (b) Shopping Mall Scenario We first observe how the throughput can be impacted with varying seed set size of spreading 12 900 1000 1100 1200 1300 1400 1500 1600 0 2 4 6 8 10Througput (kb/s)Seed set sizeRCFDegreeRandom 750 800 850 900 950 1000 1050 1100 1150 1200 1250 0 2 4 6 8 10Througput (kb/s)Seed set sizeRCFDegreeRandom rumors in the OSN. In Figure 3, for both scenarios, the throughput of the cellular network experiences substantial decreases after the rumor propagation. The decrements are higher with increasing number of seeds (i.e. critical nodes). With RCF, the damage to throughput is severer than other approaches, which means that RCF can better reveal the critical nodes. The gap between RCF and the other methods increases significantly as more seed nodes can be selected. In Figure 3a, the throughput drops 40% when 10 critical nodes outputted by RCF are used as seeds of rumor. It is worth noticing that even the random approach can lead to noticeable decrease in throughput. Therefore, the interdependent cellular/social networks is vulnerable not only to rumors that are intentionally spread, but also to those that are randomly originated. Figure 4: Stadium versus Shop- ping Mall: higher social connec- tivity results in faster drop of throughput Figure 5: Extra bandwidth re- quirement for the stadium sce- nario Figure 6: Impact of user aware- ness on network throughput (adversary's budget is 10) Next, we examine how social connectivity impacts the throughput. In theory, in a network with higher level of social connections, rumors can cause larger influence than a network with less social connections, with the same seed set size. Therefore, the cellular network can be more vulnerable when the interdependent OSN is more densely connected. The result depicted in Figure 4 supports the analysis. At each seed set size, we calculate the relative throughput decrease Qk for different scenarios. Denote the throughput after rumor propagation with k seed nodes as Tk, we define Qk = T0−Tk × 100%. T0 As can be seen from Figure 4, Qk for the shopping mall scenario increases faster in most of the cases, which demonstrates that the social connections actually aid the rumor propagation, as well as increase the vulnerability. The slow increase in Qk for the shopping mall scenario after seed set size 8 can be interpreted as a saturation case, that all D2D users are already influenced and the throughput cannot be further decreased. It explains why Qk of the stadium scenario surpasses that of the shopping mall scenario after seed set size 8. Then, we show in Figure 5 the additional bandwidth cost requirement that arises from increasing the throughput to the level before rumor propagation. Consistent with our previous findings, the critical nodes found by RCF result in the largest bandwidth requirement and thus exerts the highest pressure to the BS. After the rumor propagation, the extra bandwidth required can be up to 1400Hz. When a BS runs out of its own bandwidth and fails to supply the additional bandwidth, the throughput will be decreased drastically and the data requesters can experience a low data rate, which is not preferable. However, supply the extra requirement can be costly and thus a heavy burden to the BSs. This phenomenon emphasizes how vulnerable the cellular network can be, from another direction. 13 0 5 10 15 20 25 30 35 40 45 1 2 3 4 5 6 7 8 9 10% decrease of throughputSeed set sizeResidential AreaStadium 0 200 400 600 800 1000 1200 1400 1600 0 2 4 6 8 10Extra Bandwidth (Hz)Seed set sizeRCFDegreeRandom 900 1000 1100 1200 1300 1400 1500 1600 0 0.2 0.4 0.6 0.8 1Throughput (kb/s)User awarenessRCFDegreeRandom 4.3 Reduce Vulnerability from the OSN In this section, we study how users' actions can help in reducing the vulnerability of the cellular network. In OSNs, not all users are equally sensitive to rumors of D2D communication. Users having larger exposure to related knowledge are likely to identify the rumors and remain uninfluenced. So, they are not likely to opt out using D2D nor spread the rumor. In contrast, the users with limited knowledge to D2D are susceptible to rumors and are much more likely to opt out using D2D. To quantitatively describe the users' knowledge to D2D, we use the term "User Awareness" (UA) which ranges from 0.0 to 1.0 with 1.0 means most aware of D2D related rumors. UA is in effect in the IC model in the following way. Denote the awareness for user v as Wv. In the original IC model, node u can influence node v with probability puv. With UA, the probability is modified to puv × (1 − Wv). Therefore, the most aware users (Wv = 1) can never be influenced. Clearly, when users become more aware of the rumors, the rumor propagation will be limited and the vulnerability of the cellular network to the rumors will be reduced. In this experiment, we fix the number of seed nodes at 10 and vary UA values between 0 and 1 in the stadium scenario. As the results for the shopping mall scenario have the similar trend, we choose not to include them for conciseness. Notice that we set the UA values equally for all nodes. Such a case can describe the situation in which the general public is educated about D2D and the individuals have similar awareness. Figure 6 clearly illustrates the trend that when the user are more aware, the cellular network is less vulnerable in terms of throughput. For the degree based and random methods, the throughput recovered linearly with respect to the increase of UA. However, the seed nodes selected by RCF are "resistant" to UA. When the UA value is 0.2, the throughput after the RCF based rumor propagation only increased by 5% compared with the case without UA. This experiment illustrates that the cellular network can still be vulnerable in the worst case, even if users start to be aware of the rumors. To have a thorough understanding of UA, we now present the network throughput achieved by RCF for different values of user awareness values under various seed set size. Figure 7 is the heat map representing the impact of user awareness and the number of critical nodes on the network throughput. The throughput is depicted by the RGB colors. As the throughput value gets higher, the color becomes lighter in the heat map. From Figure 7a, we can see that the color is the lightest, i.e. the throughput is the highest, in the top left corner where the number of critical nodes is the least and the users are the most aware. (a) The Heat Map (b) A snap shot from Figure (a): Effect of the seed set size on the throughput. Figure 7: Impact of user awareness on network throughput Figure 8: BS incentivizes devices to block impact from rumors. Sample horizontal and vertical stripes are taken in the heat map and plotted in Figure 7b. The throughputs are shown for four different user awareness levels (1.0, 0.4, 0.2, 0.0). As users become more prone to rumors, which is captured by smaller user awareness values, the network throughput 14 Seed set size246810User awareness0.00.20.40.6100011001200130014001500 900 1000 1100 1200 1300 1400 1500 1600 1 2 3 4 5 6 7 8 9 10Throughput (kb/s)Seed set size1.00.40.20.0 0 10 20 30 40 50 60 1 2 3 4 5 6 7 8 9 10Throughput (kb/s) % gainBase station budgetRCFDegreeRandom decreases for fixed seed set size. On the other hand, when the number of seed users increases, the throughput decreases for a given user awareness. 4.4 Reduce Vulnerability from the Cellular Network In Section 4.3, we demonstrate that the vulnerability can be reduced when the users can identify rumors about D2D and thus limit rumor propagation in the OSN. However, improve awareness for the general public may take time. In the meantime, the BS is responsible to ensure the usual network operation and continue to offer the best service. In this section, we discuss how the vulnerability can be reduced from the cellular network. To this end, the BS can identify the critical users to the D2D communication and incentivize them to stay using D2D. Using the same criticalness evaluation scheme, the BS can rank the devices based on their criticalness values. Once the top-ranked devices are identified, the BS offers those devices incentive to keep them in the cellular network. We now investigate how network throughput will change when the critical users are retained. Figure 8 expresses the scenario where BS has a budget to incentivize the devices in the cellular In this experiment, we again use the stadium scenario only for conciseness and fix the network. number of critical nodes to 10. We measure the performance of the incentive based approach in terms of throughput gain Gl when the BS has budget l. Denote T l 10 as the throughput calculated by RCF in the situation where the number of critical nodes is 10 and the BS has budget of l. Define Gl = Gl−T l , we can observe that the more budget the BS has, the larger throughput gain it achieves. Interestingly, this critical user retention scheme is much more effective against RCF compared with the other two approaches for critical nodes identification. The throughput gain is over 50% with BS budget of 10. This result suggests that incentives can be effective for reducing the vulnerability of the cellular network. T l 10 10 5 Conclusion In this paper, we investigated the vulnerability of D2D communication from interdependent OSN. To evaluate the vulnerability, we proposed the problem TMIN to find the critical nodes in the OSN. Then we developed a solution framework RCF to TMIN and discussed how it can be extended to consider general flow/diffusion networks. By experimental evaluation, we quantitatively demonstrated how vulnerable the cellular networks could be when rumors can propagate in the interdependent OSN. Also, we illustrated two possible approaches to reduce the vulnerability. References [1] Cisco Visual Networking Index Cisco. Global mobile data traffic forecast update, 2015 -- 2020. white paper, 2016. [2] Klaus Doppler, Mika Rinne, Carl Wijting, C´assio B Ribeiro, and Klaus Hugl. Device-to-device communication as an underlay to lte-advanced networks. Communications Magazine, IEEE, 47(12):42 -- 49, 2009. [3] Chia-Hao Yu, Klaus Doppler, Cassio B Ribeiro, and Olav Tirkkonen. Resource sharing optimiza- tion for device-to-device communication underlaying cellular networks. Wireless Communications, IEEE Transactions on, 10(8):2752 -- 2763, 2011. 15 [4] G´abor Fodor, Erik Dahlman, Gunnar Mildh, Stefan Parkvall, Norbert Reider, Gyorgy Mikl´os, and Zolt´an Tur´anyi. Design aspects of network assisted device-to-device communications. Com- munications Magazine, IEEE, 50(3):170 -- 177, 2012. [5] Lei Lei, Zhangdui Zhong, Chuang Lin, and Xuemin Shen. Operator controlled device-to-device communications in lte-advanced networks. IEEE Wireless Communications, 19(3):96, 2012. [6] Nam P Nguyen, Ying Xuan, and My T Thai. A novel method for worm containment on dynamic social networks. In Military Communications Conference, 2010-MILCOM 2010, pages 2180 -- 2185. IEEE, 2010. [7] Nam P Nguyen, Guanhua Yan, My T Thai, and Stephan Eidenbenz. Containment of misinfor- mation spread in online social networks. In Proceedings of the 4th Annual ACM Web Science Conference, pages 213 -- 222. ACM, 2012. [8] Lidan Fan, Zaixin Lu, Weili Wu, Bhavani Thuraisingham, Huan Ma, and Yuanjun Bi. Least cost rumor blocking in social networks. In Distributed Computing Systems (ICDCS), 2013 IEEE 33rd International Conference on, pages 540 -- 549. IEEE, 2013. [9] Chia-Hao Yu, Olav Tirkkonen, Klaus Doppler, and C´assio Ribeiro. On the performance of device- to-device underlay communication with simple power control. In Vehicular Technology Confer- ence, 2009. VTC Spring 2009. IEEE 69th, pages 1 -- 5. IEEE, 2009. [10] Chia-Hao Yu, Olav Tirkkonen, Klaus Doppler, and C´assio Ribeiro. Power optimization of device- to-device communication underlaying cellular communication. In Communications, 2009. ICC'09. IEEE International Conference on, pages 1 -- 5. IEEE, 2009. [11] Pekka Janis, Visa Koivunen, C´assio Ribeiro, Juha Korhonen, Klaus Doppler, and Klaus Hugl. Interference-aware resource allocation for device-to-device radio underlaying cellular networks. In Vehicular Technology Conference, 2009. VTC Spring 2009. IEEE 69th, pages 1 -- 5. IEEE, 2009. [12] Ritesh Madan, Jaber Borran, Ashwin Sampath, Naga Bhushan, Aamod Khandekar, and Tingfang Ji. Cell association and interference coordination in heterogeneous lte-a cellular networks. Selected Areas in Communications, IEEE Journal on, 28(9):1479 -- 1489, 2010. [13] Shaoyi Xu, Haiming Wang, Tao Chen, Qing Huang, and Tao Peng. Effective interference can- cellation scheme for device-to-device communication underlaying cellular networks. In Vehicular Technology Conference Fall (VTC 2010-Fall), 2010 IEEE 72nd, pages 1 -- 5. IEEE, 2010. [14] Hongnian Xing and Sami Hakola. The investigation of power control schemes for a device-to- device communication integrated into ofdma cellular system. In Personal Indoor and Mobile Radio Communications (PIMRC), 2010 IEEE 21st International Symposium on, pages 1775 -- 1780. IEEE, 2010. [15] Hyunkee Min, Jemin Lee, Sungsoo Park, and Daesik Hong. Capacity enhancement using an in- terference limited area for device-to-device uplink underlaying cellular networks. Wireless Com- munications, IEEE Transactions on, 10(12):3995 -- 4000, 2011. [16] Bo Han, Pan Hui, VS Anil Kumar, Madhav V Marathe, Jianhua Shao, and Aravind Srinivasan. Mobile data offloading through opportunistic communications and social participation. Mobile Computing, IEEE Transactions on, 11(5):821 -- 834, 2012. [17] Yiyang Pei and Ying-Chang Liang. Resource allocation for device-to-device communications over- laying two-way cellular networks. Wireless Communications, IEEE Transactions on, 12(7):3611 -- 3621, 2013. 16 [18] Feiran Wang, Chen Xu, Lingyang Song, Qun Zhao, Xiaoli Wang, and Zhu Han. Energy-aware resource allocation for device-to-device underlay communication. In Communications (ICC), 2013 IEEE International Conference on, pages 6076 -- 6080. IEEE, 2013. [19] Feiran Wang, Lingyang Song, Zhu Han, Qun Zhao, and Xiaoli Wang. Joint scheduling and resource allocation for device-to-device underlay communication. In Wireless Communications and Networking Conference (WCNC), 2013 IEEE, pages 134 -- 139. IEEE, 2013. [20] Rongqing Zhang, Lingyang Song, Zhu Han, Xiang Cheng, and Bingli Jiao. Distributed resource allocation for device-to-device communications underlaying cellular networks. In Communications (ICC), 2013 IEEE International Conference on, pages 1889 -- 1893. IEEE, 2013. [21] Dong Heon Lee, Kae Won Choi, Wha Sook Jeon, and Dong Geun Jeong. Resource allocation scheme for device-to-device communication for maximizing spatial reuse. In Wireless Communi- cations and Networking Conference (WCNC), 2013 IEEE, pages 112 -- 117. IEEE, 2013. [22] Chen Xu, Lingyang Song, Zhu Han, Qun Zhao, Xiaoli Wang, Xiang Cheng, and Bingli Jiao. Efficiency resource allocation for device-to-device underlay communication systems: a reverse iterative combinatorial auction based approach. Selected Areas in Communications, IEEE Journal on, 31(9):348 -- 358, 2013. [23] Xu Chen, Brian Proulx, Xiaowen Gong, and Junshan Zhang. Exploiting social ties for cooperative d2d communications: a mobile social networking case. Networking, IEEE/ACM Transactions on, 23(5):1471 -- 1484, 2015. [24] Yanru Zhang, Erte Pan, Lingyang Song, Walid Saad, Zaher Dawy, and Zhu Han. Social network aware device-to-device communication in wireless networks. Wireless Communications, IEEE Transactions on, 14(1):177 -- 190, 2015. [25] Yong Li, Depeng Jin, Pan Hui, and Zhu Han. Optimal base station scheduling for device-to-device communication underlaying cellular networks. Selected Areas in Communications, IEEE Journal on, 34(1):27 -- 40, 2016. [26] Nam P Nguyen, Thang N Dinh, Dung T Nguyen, and My T Thai. Overlapping community structures and their detection on social networks. In Privacy, Security, Risk and Trust (PASSAT) and 2011 IEEE Third Inernational Conference on Social Computing (SocialCom), 2011 IEEE Third International Conference on, pages 35 -- 40. IEEE, 2011. [27] Md Abdul Alim, Tianyi Pan, My T Thai, and Walid Saad. Leveraging social communities for optimizing cellular device-to-device communications. IEEE Transactions on Wireless Communi- cations, 2016. [28] David Kempe, Jon Kleinberg, and ´Eva Tardos. Maximizing the spread of influence through a social network. In Proceedings of the ninth ACM SIGKDD international conference on Knowledge discovery and data mining, pages 137 -- 146. ACM, 2003. [29] Jure Leskovec, Andreas Krause, Carlos Guestrin, Christos Faloutsos, Jeanne VanBriesen, and Natalie Glance. Cost-effective outbreak detection in networks. In Proceedings of the 13th ACM SIGKDD international conference on Knowledge discovery and data mining, pages 420 -- 429. ACM, 2007. [30] Wei Chen, Yajun Wang, and Siyu Yang. Efficient influence maximization in social networks. In Proceedings of the 15th ACM SIGKDD international conference on Knowledge discovery and data mining, pages 199 -- 208. ACM, 2009. 17 [31] Amit Goyal, Wei Lu, and Laks VS Lakshmanan. Celf++: optimizing the greedy algorithm for influence maximization in social networks. In Proceedings of the 20th international conference companion on World wide web, pages 47 -- 48. ACM, 2011. [32] Wei Chen, Chi Wang, and Yajun Wang. Scalable influence maximization for prevalent viral marketing in large-scale social networks. In Proceedings of the 16th ACM SIGKDD international conference on Knowledge discovery and data mining, pages 1029 -- 1038. ACM, 2010. [33] Amit Goyal, Wei Lu, and Laks VS Lakshmanan. Simpath: An efficient algorithm for influ- ence maximization under the linear threshold model. In Data Mining (ICDM), 2011 IEEE 11th International Conference on, pages 211 -- 220. IEEE, 2011. [34] Kyomin Jung, Wooram Heo, and Wei Chen. Irie: Scalable and robust influence maximization in social networks. In Data Mining (ICDM), 2012 IEEE 12th International Conference on, pages 918 -- 923. IEEE, 2012. [35] Thang N Dinh, Dung T Nguyen, and My T Thai. Cheap, easy, and massively effective viral marketing in social networks: truth or fiction? In Proceedings of the 23rd ACM conference on Hypertext and social media, pages 165 -- 174. ACM, 2012. [36] Thang N Dinh, Huiyuan Zhang, Dzung T Nguyen, and My T Thai. Cost-effective viral mar- keting for time-critical campaigns in large-scale social networks. IEEE/ACM Transactions on Networking, 22(6):2001 -- 2011, 2014. [37] Christian Borgs, Michael Brautbar, Jennifer Chayes, and Brendan Lucier. Maximizing social in- fluence in nearly optimal time. In Proceedings of the Twenty-Fifth Annual ACM-SIAM Symposium on Discrete Algorithms, pages 946 -- 957. SIAM, 2014. [38] Youze Tang, Xiaokui Xiao, and Yanchen Shi. Influence maximization: Near-optimal time com- plexity meets practical efficiency. In Proceedings of the 2014 ACM SIGMOD international con- ference on Management of data, pages 75 -- 86. ACM, 2014. [39] Youze Tang, Yanchen Shi, and Xiaokui Xiao. Influence maximization in near-linear time: A martingale approach. In Proceedings of the 2015 ACM SIGMOD International Conference on Management of Data, pages 1539 -- 1554. ACM, 2015. [40] Hung T. Nguyen, My T. Thai, and Thang N. Dinh. Cost-aware targeted viral marketing in billion-scale networks. In Computer Communications (INFOCOM), 2016 IEEE Conference on. IEEE, 2016. [41] Vijay V Vazirani. Approximation algorithms. Springer Science & Business Media, 2013. [42] Stanford Network Analysis Project. http://snap.stanford.edu/. [43] Julian J McAuley and Jure Leskovec. Learning to discover social circles in ego networks. In NIPS, volume 2012, pages 548 -- 56, 2012. A Proofs Proof for Theorem 1. Proof. We introduce the following two lemmas for the proof. 18 Lemma 2. [39] For any  > 0, T(cid:88) P r[ xi − T µX ≥ T µX ] ≤ e − 2 2+ 2 3  T µX Lemma 3. [39] If the number of RR sets is at least i=1 Q∗ = 2V sφ2 Ic(S∗) where φ = τ = (cid:115) (1 − 1/e)σ + τ  (1 − 1 e )(ln , σ = (cid:19) (cid:18)V s k (32) (cid:114) ln( 3 δ ) + ln 3 δ ) The seed set ¯S outputted by Alg. 3 satisfies with probability at least 1 − 2δ 3 . Ic( ¯S) ≥ (1 − 1 e − )Ic(S∗) Notice that Lemma 3 is not in its original form, as we substitute δ with 2δ 3 . Next, we show that when Alg. 3 stops, the event that the total number of RR sets R generated is less than Q∗ can happen with probability at most δ 3 . ¯S = min{1, ¯S ∩ R} where R is a random RR set. Here we consider Bernoulli random variables X i Due to the BSA sampling algorithm [40], the mean of X ¯S is µX ¯S = Ic( ¯S) Ω . i=1 i=1 X ¯S] Pr[R ≤ Q∗] ≤ Pr[ R(cid:88) X ¯S ≤ Q∗(cid:88) = Pr[degR( ¯S) ≤ Q∗(cid:88) X ¯S] ≤ P r[γ ≤ Q∗(cid:88) X ¯S] × ΩIc(S∗) V sIc( ¯S) φ2 Q∗µX ¯S φ2 )Q∗ × Ic( ¯S) (1 + log 3 δ Q∗(cid:88) ≤ P r[ ≤ P r[ i=1 1 3 δ i=1 Ω 1 ≤ Q∗(cid:88) i=1 X ¯S] ΩIc(S∗) V sIc( ¯S) ] Q∗µX ¯S ) (Lemma 2) i=1 X ¯S − Q∗µX ¯S ≥ log φ2 )2( ΩIc(S∗) 1 δ δ 1 ≤ exp(− (log 3 2 + 2 ≤ exp(− (log 3 2 log 3 δ 1 ≤ exp(− log 3 V sIc( ¯S) )2 φ2 ) ΩIc(S∗) 3 (log 3 V sIc( ¯S) φ2 )2Ic(S∗) φ2V s Q∗) φ2 Ic(S∗) Q∗) ≤ δ 2V s 3 1 1 δ δ Combining Lemma 3 and the result above, by union bound, we obtain the desired result for Theorem 1. 19
1904.03596
2
1904
2019-07-17T01:23:39
Hybrid Approaches to Detect Comments Violating Macro Norms on Reddit
[ "cs.SI" ]
In this dataset paper, we present a three-stage process to collect Reddit comments that are removed comments by moderators of several subreddits, for violating subreddit rules and guidelines. Other than the fact that these comments were flagged by moderators for violating community norms, we do not have any other information regarding the nature of the violations. Through this procedure, we collect over 2M comments removed by moderators of 100 different Reddit communities, and publicly release the data. Working with this dataset of removed comments, we identify 8 macro norms---norms that are widely enforced on most parts of Reddit. We extract these macro norms by employing a hybrid approach---classification, topic modeling, and open-coding---on comments identified to be norm violations within at least 85 out of the 100 study subreddits. Finally, we label over 40K Reddit comments removed by moderators according to the specific type of macro norm being violated, and make this dataset publicly available. By breaking down a collection of removed comments into more granular types of macro norm violation, our dataset can be used to train more nuanced machine learning classifiers for online moderation.
cs.SI
cs
Hybrid Approaches to Detect Comments Violating Macro Norms on Reddit 9 1 0 2 l u J 7 1 ] I S . s c [ 2 v 6 9 5 3 0 . 4 0 9 1 : v i X r a Eshwar Chandrasekharan Georgia Institute of Technology Atlanta, Georgia, USA [email protected] ABSTRACT In this dataset paper, we present a three-stage process to collect Reddit comments that are removed comments by moderators of several subreddits, for violating subreddit rules and guidelines. Other than the fact that these com- ments were flagged by moderators for violating community norms, we do not have any other information regarding the nature of the violations. Through this procedure, we collect over 2M comments removed by moderators of 100 different Reddit communities, and publicly release the data. Working with this dataset of removed comments, we identify 8 macro norms -- norms that are widely enforced on most parts of Red- dit. We extract these macro norms by employing a hybrid approach -- classification, topic modeling, and open-coding -- on comments identified to be norm violations within at least 85 out of the 100 study subreddits. Finally, we label over 40K Reddit comments removed by moderators according to the specific type of macro norm being violated, and make this dataset publicly available. By breaking down a collection of removed comments into more granular types of macro norm violation, our dataset can be used to train more nuanced machine learning classifiers for online moderation. KEYWORDS social computing; online communities; community norms; online moderation; mixed methods. 1 INTRODUCTION Reddit is organized into over one million user-created on- line communities1 known as subreddits, and the platform has a multi-layered architecture for regulating behaviors. At a site-wide level, Reddit has content and anti-harassment policies that all subreddits are expected to follow. Whenever subreddits are found to continuously violate policies, Reddit is known to intervene and ban these forums and associated user accounts [4]. Additionally, each subreddit has its own set of subreddit-specific rules and guidelines regarding sub- missions, comments, and user behaviors [9, 11]. Like many online platforms, Reddit relies on volunteer moderators (or University of Michigan Ann Arbor, Michigan, USA Eric Gilbert [email protected] "mods") to enforce the rules and guidelines within subred- dits by sanctioning norm violating content (e.g., comment removal) and users (e.g., banning). We compile a dataset of comments that moderators re- moved from Reddit for violating subreddit rules and guide- lines. Other than the fact that these comments were flagged by the moderators as being violations, we do not have any other information regarding the nature of these comments. Our goal is to generate training data for building machine learning tools that can automatically detect nuanced norm violations, including antisocial behaviors like trolling [7] and hate speech [8, 12, 13], and thereby mimic the actions taken by moderators of different subreddits. In order to do this task, we propose an approach that is more granular than a simple binary classification task (i.e., a binary classifier that predicts if a given comment is either a violation or not, as marked by the moderators). We introduce additional super- vision into our dataset of removed comments, by automati- cally categorizing content based on the types of violations they represent in a large-scale, computational manner. By adopting a hybrid approach -- classification, topic modeling, and open-coding -- we map over 40,000 removed comments collected from 100 different communities on Reddit, to the specific type of norms they violate. Summary of contributions First, we present a three-stage process to collect Reddit com- ments that were removed by moderators for violating com- munity norms, and publicly release over 2M removed com- ments from top 100 subreddits. Next, we introduce a hybrid approach to detect 8 different types of macro norms on Red- dit (i.e., norms that are widely enforced on most parts of Reddit). Finally, we automatically label over 40,000 Reddit comments removed by moderators according to the specific type of norms being violated. The dataset 2 containing all 2M removed comments, along with the 40K labeled macro norm violations generated in this paper can be found online. All of the removed comments from Reddit, and the norm extrac- tion (using a mix of classification, topic models and manual annotation) were generated as part of our prior work [5]. 1http://redditmetrics.com/history 2https://doi.org/10.5281/zenodo.3338698 Figure 1: Flowchart describing the three stages involved in our collection of Reddit comments removed by moderators. Ethical considerations We recognize that the use of "deleted data" (here in the form of comments removed from Reddit) is controversial territory in social computing research. We discussed these issues in detail with the Institutional Review Board and our colleagues, before conducting this research. In the end, we concluded that examining removed comments provides key insights into how online communities are governed, and those bene- fits outweighed any downside risks, as long as the risks are mitigated. For example, we believe that our findings and data may enable new mixed-initiative moderation tools for on- line communities. We actively worked to minimize potential risks by not linking removed comments in our dataset back to their authors or subreddits (who may not want to be im- mortalized in a research paper next to their norm violation). Moreover, we did not use comments that were deleted by their authors in this work, as those felt qualitatively different to everyone with whom we discussed this research. Finally, we only collected public data through Reddit's official API, in an effort to protect Reddit itself from any harm. 2 COLLECTING REMOVED REDDIT COMMENTS Next, we describe our three-stage process to collect Reddit comments that were removed by moderators. An illustration of this approach is shown in Figure 1. Corpus of removed Reddit comments (D) We constructed a dataset that included all Reddit comments that were moderated off-site3 during a 10-month period, from May 2016 to March 2017, in a three-stage process. Stage 1: Streaming Reddit comments using Reddit API. We used the Reddit streaming API 4 to continuously crawl all comments as they were posted on Reddit. Essentially, these were all comments posted to r/all, and they can be from any subreddit that is not "private," and chose to post its content to r/all. We stored all the comments obtained from the stream in a master log file that was maintained locally. 3Therefore, these comments were no longer publicly visible on the internet at the time of data collection. 4https://praw.readthedocs.io/en/latest Stage 2: Querying the Reddit API after a 24-hour delay. After a 24-hour delay, we queried the Reddit API for each comment that was collected in the past day. In order to do this, we used each comment's unique comment_ID, which was stored in our master log file during Stage 1. If a comment is removed by a moderator, then the text that was previously present in the comment (represented in the "body" field) is replaced with ["removed"], and all other attributes of the comment, except the "comment_ID" (unique identifier), are discarded. Essentially, none of the fields that were previously associated to a comment are available publicly after its removal. It is important to distinguish between a comment that was taken down by a moderator from a comment that was taken down by the author themselves. Prior work has shown that it is possible to do so -- only when moderators or admins remove a comment, its text is replaced by ["removed"], and most comments violating norms are moderated within the first 24 hours of posting on the subreddit [5]. Using this method, we compiled the unique identifiers, or "comment_IDs", of all comments that were removed by moderators in the last day. Stage 3: Obtaining missing data for removed comments. As mentioned earlier, all the attributes of a comment (except its unique identifier, or comment_ID) are discarded following its removal. In order to retrieve these missing fields, we performed a look-back step using the data present in our master log. For each removed comment we identified in the Stage 2, we performed a look-up in the master log file (compiled in Stage 1), using the comment_IDs of the removed comment. Through this look-up, we obtained all the fields that were previously contained in the removed comments (like 'body', 'subreddit', 'author', and so on) before it was removed by moderators. Using this 3-stage process, we collected 4,605,947 mod- erated comments that were removed from Reddit during a 10-month period, from May 2016 to March 2017. All of the removed comments we identified constitute our Reddit mod- erated comments corpus (denoted by D in the remainder of the paper). 2 Stream Reddit comments continuously to local disk using the Reddit APIQuery the API for comments by ID after a 24-hour delay to identify moderator removalsObtain missing attributes for removed comments through local disk look-upSTAGE 1STAGE 2STAGE 3 Discarding spurious comments in D Next, we discarded comments present in D, based on three different criteria mentioned below: • Replies by AutoModerator: We discarded 101,502 com- ments from D, that were authored by AutoModerator, a moderation bot used to automatically remove con- tent based on predefined rules.5 Since these comments were just warnings issued to users following actual removals, we do not consider them as norm violations in our analysis. • Replies to removed comments: Through conversations with moderators, we learned that sometimes when a comment is removed, all its replies are also removed automatically. So, we discarded 1,051,623 comments from D, which were identified to be replies to removed comments, since they may not have been removed because they violated a norm (rather because they replied to a comment that did). • Comments from non-English subreddits: Next, we used langdetect 6 and examined all comments from subred- dits to decide whether interactions are predominantly in English or not. As a result, we discarded all com- ments from any non-English subreddits present in D, giving us the final dataset for further analysis. Identifying study subreddits After preprocessing the data by discarding spurious com- ments, there remained over 3 million moderated comments contained in D, and they were collected from 41,097 unique subreddits. In order to build robust machine learning (ML) classifiers, we restricted our analysis only to the subreddits for which we were able to collect a reasonable amount of moderated comments. Therefore, we discarded all subreddits that generated fewer than 5,000 moderated comments in D. Finally, 2,831,664 moderated comments remained in D, all originating within the 100 subreddits generating the most re- moved comments in our corpus. We call these 100 subreddits our study subreddits7, and denote their removed comments by M for the rest of this paper. We made the entire dataset of removed comments obtained from the 100 subreddits post- filtering publicly available. Description of study subreddits. At the time of our analysis, the study subreddits had an average 5.76 million subscribers, with r/funny having the highest subscriber count (19 mil- lion), and r/PurplePillDebate having the lowest subscriber count (16,000). On average, each subreddit contributes 20,070 moderated comments, with r/The_Donald contributing the 5https://www.reddit.com/r/AutoModerator/ 6https://pypi.python.org/pypi/langdetect 7Names of all 100 study subreddits can be found in the repo. 3 most (184,168) and r/jailbreak contributing the least (5,616) number of removed comments in M. 3 IDENTIFYING MACRO NORM VIOLATIONS USING SUBREDDIT CLASSIFIERS In our prior work, we have detailed the procedure used to train classifiers that can predict moderator removals within the study subreddits [5]. Using the comments that were re- moved by moderators of each study subreddit, along with unremoved comments collected from study subreddits, we trained machine learning models to predict whether a com- ment posted on the subreddit will get removed by moderators or not. Summary: Training subreddit classifiers First, we trained in-domain classifiers to predict whether a comment posted on a subreddit will get removed by a moderator or not. We used fasttext, which is a state-of-the- art library for text classification [2, 10]. fasttext represents each instance by the average of vector representations for words and n-grams, which are short units of adjacent words. For each study subreddit Sk, we built a classifier cl fSk trained on comments removed by moderators of Sk, along with an equal number of randomly sampled comments from Sk that were not removed, at the time of our data collection (i.e., unremoved comments). We refer to each in-domain clas- sifier built entirely using removed and unremoved comments from a single subreddit as a "subreddit classifier". We built 100 such subreddit classifiers, one for each of our study sub- reddits. For detailed descriptions of the construction of our 100 subreddit classifiers, and evaluation of the in-domain classifiers through 10-fold cross-validation tests, please refer to our prior work [5]. Agreement among subreddit classifiers Next, we obtained predictions from each subreddit classifier (e.g., cl fSk ) for each comment present in M, and generated a prediction matrix. Columns in this matrix are comments in M, and rows are subreddit classifiers. Each cell [i,j] in the prediction matrix contains a yes or no, depending on what classifier cl fSi predicted for comment mj: If mj were hypo- thetically posted on Si, would it get removed by a moderator? The output of this step is a prediction matrix, with number of rows equal to the number of comments in M (2M), and the number of columns equal to the number of subreddits for which we have trained classifiers (100). Using the prediction matrix, we computed the overall agreement among all subreddit classifiers' predictions for each removed comment present in M. By overall agreement among subreddit classifiers, we refer to the number of classi- fiers that predict to remove the same comment. Figure 2: Based on agreement among subreddit classifiers, we identified the comments in M that are considered to be norm violations on most parts of Reddit (i.e., macro norm violations). Using these comments, we first performed topic modeling to identify the top 10 topics contained within them. Finally, we employed open coding to label the 10 topics we identified earlier, using 10 comments that ranked highly in each of the topics as context, by the norms they violated. Through this hybrid procedure, we extracted macro norms that are enforced on most parts of Reddit. Comments violating macro norms Based on the amount of agreement among subreddit clas- sifiers, we identified comments that a large majority of the 100 subreddit classifiers agreed to remove. In particular, we identify comments that a large majority (at least 85 out of 100) of the study subreddit classifiers agreed to remove. It is likely that something in the comment violates a norm shared widely on Reddit, and we consider these comments to be norm violations at a macro level, or macro norm violations. Using the text contained in these comments, we will extract norms that extend across most study subreddits. In turn, we call these macro norms, as we observe them to be enforced by moderators of a large majority of our study subreddits. 4 EXTRACTING MACRO NORMS THROUGH TOPIC MODELING AND OPEN CODING In order to identify the macro norms these comments vio- lated, we employed a combination of topic modeling and open coding on the macro norm violations. Topic modeling. First, we adopted a computational approach to reduce the dimensionality of our textual data. We em- ployed topic modeling on the macro norm violations to iden- tify the underlying topics contained in these comments. Ap- plying Latent Dirichlet Allocation (LDA) [1], we estimated topic distributions on the comments found to be macro norm 4 violations. We used LDA to estimate the topic distributions among 10 topics. Every comment we analyzed is consid- ered to be a document for this analysis. In further analysis, we tested by increasing the number of topics from 10 to 20 for LDA, but observed that no new types of macro norms emerged. As a result, we only estimated topic distributions among 10 topics. Open coding: Map topics to types of norm violation. Next, we introduced a qualitative step, where we used open coding to manually label each topic by the norm violation it represents (in the form of a 1-2 line explanation behind the comment's removal). Using the topic distribution computed for macro norm violations, we identified 10 comments that ranked highly in each of the 10 topics obtained. Then, three annota- tors independently labelled each topic by the norm violation it represents, using the 10 comments ranking highly in that topic as context. This way, we manually labelled all 10 topics (using 10 randomly sampled comments for context) by their respective macro norms. Then, the three annotators came together to compare the norms they coded independently, and resolved any disagreements. Through this process, we extracted the 8 macro norms contained in M. The raw an- notation data, along with all three labels assigned by the independent coders, are available upon request. t1t2t10m'1m'2 . . . m'10macro norm2m1m2 . . . mnTopic modelOpen codingSort M by topicdistribution...M Macro norm violation Using misogynistic slurs Opposing political views around Donald Trump (depends on originating subreddit) Hate speech that is racist or homophobic Verbal attacks on Reddit or specific subreddits Posting pornographic links Personal attacks Abusing and criticizing moderators Name-calling or claiming the other person is too sensitive Table 1: Macro-norms extracted by analyzing removed comments that at least 85 out of 100 subreddit classifiers predicted to remove from their respective subreddits. 5 RESULTS Working with over 2.8M removed comments collected from 100 communities on Reddit, we identified 8 macro norms, which are shown in Table 1. We extracted these macro norms by employing a hybrid approach -- classification, topic model- ing, and open-coding -- on comments identified to be macro norm violations in at least 85 out of the 100 study subreddits. Macro norms on Reddit Hate speech in the form of homophobic and racist slurs are considered as norm violations on most parts of Reddit. We also found that name-calling, using misogynistic slurs, graphic verbal attacks, and distributing pornographic mate- rial are sanctioned. Comments presenting opposing political views around Donald Trump, either for or against depending on originating subreddit, are also removed by moderators. Such content could potentially lead to highly polarized com- ment threads, thereby hijacking ongoing discourse towards unrelated topics. This indicates that such comments are con- sidered to be norm violations on Reddit because they hurt the process of discussion, and not necessarily because they are universally abhorrent. Another common macro-norm violation is criticizing and abusing moderators. These are mostly instances where mem- bers of the community express their discontent with mod- erator actions (e.g., removing or promoting certain posts, and the need for transparency in the moderation process). Sometimes, this discontent goes beyond certain specific sub- reddits, and we found that users verbally attack Reddit (and its admins) due to a variety of reasons (e.g., policy changes, banning communities, and so on). In such cases, the modera- tors of subreddits intervened and removed such comments. Map comments in M to macro norms Using the topics labeled by the type of norm violation they denote, obtained in the previous section and shown in Ta- ble 1, we transformed all the removed comments present in M. Essentially, we mapped all removed comments in M to the respective macro norms they are likely to have violated. Using the pre-trained LDA topic models, we obtained topic distributions for removed comments in M. This way, we get a sense for the distribution of labeled topics, that were learned by training a topic model on removed comments that were considered to be macro norm violations (i.e., agreed to be removed by at least 85% of the study subreddit classi- fiers). This approach enabled us to examine and compare the landscape of incoming norm violations, which were even- tually removed by subreddit moderators, in a large-scale, computational manner. The labeled topics, along with their word distributions, and types of norm violations are shown in the Github repo.8 For each of the labeled topics, we identified the top 5000 comments in M that were best fit by the topic model. In this way, we identified over 5000 removed comments that are examples of each type of norm violation shown in Table 1. The removed comments were sorted by their topic fit, stored into respective files based on the type of norm violation they represent, and made available on the Github repo9. 6 DISCUSSION After compiling a corpus of over 2M comments (M) that were removed by moderators of different communities on Reddit, we categorized each comment by the type of norm it violated, in a large-scale, computational manner. Using a combination of classification, topic modelling, and human annotation, we presented a novel hybrid approach to detect macro-level norm violations on Reddit. 8https://github.com/ceshwar/reddit-norm-violations/blob/master/ README.md 9https://github.com/ceshwar/reddit-norm-violations/tree/master/data/ macro-norm-violations 5 Training nuanced tools for online moderation By breaking down our collection of removed comments into more granular violation-types, our dataset can be used to train more nuanced machine learning classifiers for online moderation. Classifiers trained to detect comments violating the specific types of macro norms we identified in this pa- per, can detect subtle norm violations, that a simple binary classifier may not be able to identify consistently. Online moderation is a highly contextual task, that needs to take community norms into consideration, before taking down any content. Encoding all the norms of a community in the form of simple removed or not decisions is not an easy task, and we may require more sophisticated approaches to detect- ing undesirable content. We believe that classifiers trained to detect the specific types of norms being violated offer more granularity and information to moderators, when compared to a simple binary classifier trained to predict whether a comment would be removed or not. This is a line of research that we plan to deeply examine in the near future. Classifiers that learn from norms enforced within other communities Our findings document the existence of norm violations that are universally removed by moderators of most subred- dits. These include comments that contain personal attacks, misogyny, and hate speech in the form of racism and homo- phobia. The presence of these macro norms are in many ways encouraging, as they indicate that engaging in such behavior is considered a norm violation site-wide. We would argue that knowing about the presence of such site-wide norms could also help moderators of new and emerging communi- ties shape their regulation policies during the community's formative stages, and feel more confident doing so. This discovery of widely overlapping norms also suggests that new automated tools for online moderation could find traction in borrowing data from communities which share similar values, or wish to establish similar norms. By under- standing the types of norms that are valued by the target community, researchers could use classifiers trained on the different types of macro norm violations contained in our dataset. In some cases, the macro norms identified in this work may even be able to serve as sensible defaults for a new online community. Large-scale approach to examine landscape of norm violations For existing and established communities, our approach presents a way to understand the landscape of norm vio- lations that are prevalent on their platform, and estimate the types of violations that their current ML models are good at identifying, allowing them to improve existing ML models 6 by focusing on the types of violations that these models are not as good at identifying. In other words, they can focus on achieving targeted gains in performance in the future iterations of the ML models by systematically training on specific types of violations that they want to consciously improve on, or for which the model has not seen enough examples of in the past. Our hope is that this will enable communities to focus on the types of violations that existing models are not as efficient at identifying, rather than just working on small, incremental performance gains on types that they are already good at identifying. 7 LIMITATIONS Our findings hinge on the algorithms we used in our methods -- the classifiers we trained, and the topic models we employed can play a role in the types of norms we uncovered. On the other hand, using these algorithms gives us the ability to study site-wide norms holistically in a large-scale empirical manner, which is not possible to do by manual inspection alone. While we find our results encouraging, they raise a number of questions, challenges and issues. Here, we reflect on some of the limitations present in our work, that are important to keep in mind when using our dataset. Noise introduced by the subreddit classifiers The mean 10-fold cross-validation F1 score obtained for the 100 study subreddit classifiers was 71.4%. This is compara- ble to the performance achieved in prior work on building purely in-domain classifiers to identify removed comments within an online community [3, 6]. But it is important to note that the subreddit classifiers are still imperfect, and could play a role in the types of comments identified to be violating macro norms (for example, it is possible there exist some false positives in our corpus of macro norm violations). Nevertheless we are confident that our methods are robust, especially given that all comments were removed by hu- man moderators, and agreement was computed across 100 different subreddit classifiers. Noise introduced by topic modeling We employed topic modeling to reduce the dimensional- ity of our textual data, and identify 10 underlying topics contained in the comments violating macro norms. After open-coding these 10 topics, we transformed all comments in M to identify their best-fit topics, and label them with the corresponding macro norm. Though this process allowed us to label large amounts of removed comments in an ef- ficient manner, there are some potential points of failures to keep in mind. Topic modeling is not perfect, and a lot of bias could be introduced by this process. There could exist a comment that ranks highly in multiple topics, leading it to be present in multiple files, even if only one of these topics is the actual best fit for that comment. As a result, there could exist comments present in the top 5000 for a topic, which do not actually violate the macro norm represented by the topic under consideration. In order to minimize this risk, we sorted comments based on their topic fit, and saved the top 5000 best-fit comments for each labeled topic into our files. Confounding factors Note that we do not know the exact reason behind each mod- erator removal, and we do not account for differing levels of moderator activity across subreddits. This lack of context for the removed comments could make interpreting the rea- sons behind moderator actions a hard task. Additionally, our current method of data collection does not give us access to removed content in the form of pictures, GIFs or videos. As a result, we were only able to identify community expectations around textual content. 8 CONCLUSION We present a three-stage process to collect comments that were removed off-site by moderators of Reddit communities for violating community norms. Through this procedure, we publicly released a large-scale dataset of moderated data that can be studied by future researchers. Next, we introduced a hybrid approach to detect macro norms on Reddit (i.e., norms that are widely enforced on most parts of of the platform) in a large-scale, computational manner. Finally, we presented a method to automatically label Reddit comments removed by moderators by the specific type of norms they violate. [7] Justin Cheng, Cristian Danescu-Niculescu-Mizil, and Jure Leskovec. 2015. Antisocial Behavior in Online Discussion Communities. In Ninth International AAAI Conference on Web and Social Media. [8] Thomas Davidson, Dana Warmsley, Michael Macy, and Ingmar Weber. 2017. Automated hate speech detection and the problem of offensive language. arXiv preprint arXiv:1703.04009 (2017). [9] Casey Fiesler, Jialun "Aaron" Jiang, Joshua McCann, Kyle Frye, and Jed R. Brubaker. 2018. Reddit Rules! Characterizing an Ecosystem of Governance. In Proceedings of the 2018 AAAI International Conference on Web and Social Media. ICWSM. [10] Armand Joulin, Edouard Grave, Piotr Bojanowski, and Tomas Mikolov. 2017. Bag of Tricks for Efficient Text Classification. In Proceedings of the 15th Conference of the European Chapter of the Association for Computational Linguistics: Volume 2, Short Papers, Vol. 2. 427 -- 431. [11] Anna Kasunic and Geoff Kaufman. 2018. " At Least the Pizzas You Make Are Hot": Norms, Values, and Abrasive Humor on the Subreddit r/RoastMe. In Twelfth International AAAI Conference on Web and Social Media. [12] Koustuv Saha, Eshwar Chandrsekharan, and Munmun De Choudhury. 2019. Prevalence and Psychological Effects of Hateful Speech in Online College Communities. In WebSci. [13] Joni Salminen, Hind Almerekhi, Milica Milenković, Soon-gyo Jung, Jisun An, Haewoon Kwak, and Bernard J Jansen. 2018. Anatomy of online hate: developing a taxonomy and machine learning models for identifying and classifying hate in online news media. In Twelfth International AAAI Conference on Web and Social Media. REFERENCES [1] David M Blei, Andrew Y Ng, and Michael I Jordan. 2003. Latent dirichlet allocation. Journal of machine Learning research 3, Jan (2003), 993 -- 1022. [2] Piotr Bojanowski, Edouard Grave, Armand Joulin, and Tomas Mikolov. 2016. Enriching word vectors with subword information. arXiv preprint arXiv:1607.04606 (2016). [3] Stevie Chancellor, Zhiyuan Jerry Lin, and Munmun De Choudhury. 2016. "This Post Will Just Get Taken Down": Characterizing Removed Pro-Eating Disorder Social Media Content. In Proceedings of the 2016 CHI Conference on Human Factors in Computing Systems. ACM, 1157 -- 1162. [4] Eshwar Chandrasekharan, Umashanthi Pavalanathan, Anirudh Srini- vasan, Adam Glynn, Jacob Eisenstein, and Eric Gilbert. 2017. You Can't Stay Here: The Efficacy of Reddit's 2015 Ban Examined Through Hate Speech. Proc. ACM Hum.-Comput. Interact. 1, CSCW, Article 31 (Dec. 2017), 22 pages. https://doi.org/10.1145/3134666 [5] Eshwar Chandrasekharan, Mattia Samory, Shagun Jhaver, Hunter Charvat, Amy Bruckman, Cliff Lampe, Jacob Eisenstein, and Eric Gilbert. 2018. The Internet's Hidden Rules: An Empirical Study of Reddit Norm Violations at Micro, Meso, and Macro Scales. Proceedings of the ACM on Human-Computer Interaction 2, CSCW (2018), 32. [6] Eshwar Chandrasekharan, Mattia Samory, Anirudh Srinivasan, and Eric Gilbert. 2017. The Bag of Communities: Identifying Abusive Behavior Online with Preexisting Internet Data. In Proceedings of the 2017 CHI Conference on Human Factors in Computing Systems. ACM. 7
1511.02647
3
1511
2016-06-03T16:33:18
Modelling influence and opinion evolution in online collective behaviour
[ "cs.SI" ]
Opinion evolution and judgment revision are mediated through social influence. Based on a large crowdsourced in vitro experiment (n=861), it is shown how a consensus model can be used to predict opinion evolution in online collective behaviour. It is the first time the predictive power of a quantitative model of opinion dynamics is tested against a real dataset. Unlike previous research on the topic, the model was validated on data which did not serve to calibrate it. This avoids to favor more complex models over more simple ones and prevents overfitting. The model is parametrized by the influenceability of each individual, a factor representing to what extent individuals incorporate external judgments. The prediction accuracy depends on prior knowledge on the participants' past behaviour. Several situations reflecting data availability are compared. When the data is scarce, the data from previous participants is used to predict how a new participant will behave. Judgment revision includes unpredictable variations which limit the potential for prediction. A first measure of unpredictability is proposed. The measure is based on a specific control experiment. More than two thirds of the prediction errors are found to occur due to unpredictability of the human judgment revision process rather than to model imperfection.
cs.SI
cs
Modelling influence and opinion evolution in online collective behaviour Corentin Vande Kerckhove1,+, Samuel Martin2,+,*, Pascal Gend2, Peter J. Rentfrow3, Julien M. Hendrickx1, Vincent D. Blondel1 1 Large graphs and networks group, Université catholique de Louvain, Avenue Georges Lemaitre, 4 B-1348 Louvain-la-Neuve, Belgium 2 Université de Lorraine, CRAN, UMR 7039 and CNRS, CRAN, UMR 7039, 2 Avenue de la Forêt de Haye, Vandoeuvre-les-Nancy, France 3 Department of Psychology, University of Cambridge + These authors contributed equally to this work. * [email protected] Abstract Opinion evolution and judgment revision are mediated through social influence. Based on a large crowdsourced in vitro experiment (n = 861), it is shown how a consensus model can be used to predict opinion evolution in online collective behaviour. It is the first time the predictive power of a quantitative model of opinion dynamics is tested against a real dataset. Unlike previous research on the topic, the model was validated on data which did not serve to calibrate it. This avoids to favor more complex models over more simple ones and prevents overfitting. The model is parametrized by the influenceability of each individual, a factor representing to what extent individuals incorporate external judgments. The prediction accuracy depends on prior knowledge on the participants' past behaviour. Several situations reflecting data availability are compared. When the data is scarce, the data from previous participants is used to predict how a new participant will behave. Judgment revision includes unpredictable variations which limit the potential for prediction. A first measure of unpredictability is proposed. The measure is based on a specific control experiment. More than two thirds of the prediction errors are found to occur due to unpredictability of the human judgment revision process rather than to model imperfection. Introduction Many individual judgments are mediated by observing others' judgments. This is true for buying products, voting for a political party or choosing to donate blood. This is particularly noticeable on the online world. The availability of online data has lead to a recent surge in trying to understand how online social influence impact human behaviour. Some in vivo large scale online experiments were devoted to understand how information and behaviours spread in online social networks [1], others focused on determining which sociological attributes such as gender or age were involved in social influence processes [2]. Although decision outcomes are often tied to an objective best choice, outcomes can hardly be fully inferred from this supposedly best choice. For instance, predicting the popularity of songs in a cultural market requires more than just knowing the actual song quality [3]. The decision outcome is rather determined by the social influence process at work [4]. Hence, there is a need for opinion dynamics models with a predictive power. Complementarily to the in vivo experiments, other recent studies used online in vitro experiment to identify the micro-level mechanisms susceptible to explain the way social influence 1 impacts human decision making [5 -- 7]. These recent online in vitro studies have lead to posit that the so-called linear consensus model may be appropriate to describe the way individuals revise their judgment when exposed to judgments of others. The predictive power of such a mechanism remains to be assessed. Trying to describe how individuals revise their judgment when subject to social influence has a long history in the psychological and social sciences. The consensus model used in this article draws from this line of work. These works were originally developed to better understand small group decision making. This occurs for instance when a jury in civil trials has to decide the amount of compensation awarded to plaintiffs [8 -- 10]. Various types of tasks have been explored by researchers. These includes the forecasts of future events e.g., predicting market sales based on previous prices and other cues [11,12], the price of products [13,14], the probability of event occurrence [15,16], such as the number of future cattle deaths [17], or regional temperatures [18]. The central ingredient entering in models of judgment revision is the weight which individuals put on the judgments of others, termed influenceability in the present article. This quantity is also known as the advice taking weight [14,17] or the weight of advice [19 -- 21]. It is represented by a number taking 0 value when the individual is not influenced and 1 when they entirely forget their own opinion to adopt the one from other individuals in the group. It has been observed that in a vast majority of the cases, the final judgment falls between the initial one and the ones from the rest of the group. Said otherwise, the influenceability lies between 0 and 1. This has been shown to sensibly improve the accuracy of decisions [22]. A 20% improvement has been found in an experiment when individuals considered the opinion of another person only [19]. However, individuals do not weight themselves and others equally. They rather overweight their own opinions [23]. This has been coined egocentric discounting [24]. Many factors affect influenceability. These include the perceived expertise of the adviser [17,25] which may result from age, education, life experience [26], the difficulty of the task [21], whether the individual feels powerful [27] or angry [28], the size of the group [29], among others. A sensitivity analysis has been carried out to determine which factors most affect advice taking [30]. This line of work has focused on determining the factors impacting influenceability. None has yet answered whether judgment revision models could be used to predict future decisions. Instead, the models were validated on the data which served to calibrate the models themselves. This pitfall tends to favor more complex models over more simple ones and may result in overfitting. The model would then be unable to predict judgment revision from a new dataset. One reason for this literature gap could be the lack of access to large judgment revision database at the time, now made more readily available via online in vitro experiments. The predictability assessment is a necessary step to grow confidence in our understanding and in turn use this mechanism as a building block to design efficient online social systems. Revising judgments after being exposed to others' judgments takes an important role in many online social systems such as recommendation system [31,32] or viral marketing campaign [33] among others. Unlike previous research, the present work provides an assessment of the model predictive power through crossvalidation of the proposed judgment revision model. The prediction accuracy of a model is limited to the extent the judgment revision process is a deterministic process. However, there is theoretical [34 -- 36] and empirical [37] evidence showing that the opinion individuals display is a sample of an internal probabilistic distribution. For instance, Vul and Pashler [37] showed that when participants were asked to provide their opinion twice with some delay in between, participants provided two different answers. Following these results, the present article details a new methodology to estimate the unpredictability level of the judgment revision mechanism. This quantifies the highest prediction accuracy one can expect. The results presented in this article were derived using in vitro online experiments, where each participant repeated several times estimation tasks in very similar conditions. These repeated experiments yielded two complementary sets of results. First, it is shown that, in presence of social influence, the way individuals revise their judgment can be modeled using a quantitative model. Unlike the previously discussed studies, the gathered data allow assessing the predictive power of the model. The model casts individuals' behaviours according to their influenceability, the factor quantifying to what extent one takes external opinions into account. Secondly, a measure of intrinsic unpredictability in judgment revision is provided. Estimating the intrinsic unpredictability provides a limit beyond which no one can expect to improve 2 predictions. This last result was made possible through a specific in vitro control experiment. Although models of opinion dynamics have been widely studied for decades by sociologist [38] from a theoretical standpoint, to the best of our knowledge, it is the first time the predictive power of a quantitative model of opinion dynamics is tested against a real dataset. Results and Discussion To quantify opinion dynamics subject to social influence, we carried out online experiments in which participants had to estimate some quantities while receiving information regarding opinions from other participants. In a first round, a participant expresses their opinion xi corresponding to their estimation related to the task. In the two subsequent rounds, the participant is exposed to a set of opinions xj of other participants who performed the same task independently, and gets to update their own opinion. The objective of the study is to model and predict how an individual revises their judgment when exposed to other opinions. Two types of games were designed : the gauging game, in which the participants evaluated color proportions and the counting game, where the task required to guess amounts of items displayed in a picture (see Experiment section in Material and Methods). Participants to this online crowdsourced study were involved in 3-round judgment revision games. Judgment revision is modeled using a time-varying influenceability consensus model. In mathematical terms, xi(r) denotes the opinion of individual i at round r and its evolution is described as xi(r + 1) = xi(r) + αi(r) · (¯x(r) − xi(r)) (1) where r = 1, 2 and where ¯x(r) is the mean opinion of the group at round r (see Opinion revision model section in Material and Methods for details and supplementary section S3 for a test of the validity of the linearity assumption). This model is based on the influenceability αi(r) of participants, a factor representing to what extent a participant incorporates external judgments. Influenceability of participants The influenceability is described for each participant by two parameters : αi(1), the in- fluenceability after first social influence and αi(2), the influenceability after second social influence. The distribution of couples (αi(1), αi(2)) were obtained by fitting model (1) to the whole dataset via mean square minimization for each type of games independently. The marginal distributions of (αi(1), αi(2)) are shown in Fig. 1. Most values fall within interval [0, 1], meaning that the next judgment falls between one's initial judgment and the group judgment mean. Such a positive influenceability has been shown to improve judgment accuracy [22] (see also the Practical Implications of the Model section). Most individuals overweight their own opinion compared to the mean opinion to revise their judgment with αi(r) < 0.5. This fact is in accordance with the related literature on the subject [23]. An interesting research direction is to link the influenceability of an individual to their personality. One way to measure personality is via the big five factors of personality [39]. It turns out that influenceability is found not to be significantly correlated to the big five factors of personality, to education level and to gender. These negative findings are reported in the Influenceability and personality supplementary section. The plots in Fig. 1 also display a small fraction of negative influenceabilities. One interpre- tation would be that the concerned participants recorded opinions very close to the average group opinion for multiple games. When this happens at one round, the opinion at the following round has a high probability to move away from the group average. This contributes to negative influenceabilities in the participants' influenceabilities during the fitting process. Is the prediction error homogeneous for all influenceability values ? To see this, each bin of the influenceability distributions in Fig. 1 is colored to reflect average prediction error. The error is given in terms of root mean square error (RMSE). The color corresponds to the prediction error regarding participants having their influenceability falling within the bin. A detailed definition of RMSE is provided in paragraph Validation procedure in Material and Methods 3 section. This information shows that the model makes the best predictions for participants with a small but non-negative influenceability. On the contrary, predictions for participants with a high influenceability are less accurate. (A) Gauging (B) Counting (C) Influenceability over rounds and games. Figure 1. (A) Gauging game, (B) Counting game : distributions of the αi(1) influenceability after the first round and αi(2) influenceability after the second round for the time-varying influenceability model (1). The colormap corresponds to the average prediction RM SE of participants in each bin. For visualization purposes, one value at αi(1) = −1.5 has been removed from the histogram in the gauging game, round 1. (There was only one individual with αi(1) = −1.5. For this particular individual, the linear relationship between xi(2)− xi(1) and ¯x(1) − xi(1) is not significant (p-val = 0.38), so that the coefficient αi(1) = −1.5 should not be interpreted. For the rest of the participants, the level of trust can be read from the color scale. The color of a bar corresponds to the average prediction error made for the participants with αi values falling within the bar range.) (C) Cumulated distributions of αi(1) and αi(2) for each type of games. 4 011.510(cid:1)()Number of players115291011.510(cid:1)()Number of players115292011.510(cid:1)()Number of players314251011.510(cid:1)()Number of players314252(cid:1)011.5CDF((cid:1))00.51(cid:1)(1) - Gauging(cid:1)(1) - Counting(cid:1)(2) - Gauging(cid:1)(2) - Counting The distribution of influenceabilities of the population is subject to evolution over time. A two-sample Kolmogorov-Smirnov test rejects equality of distributions between αi(1) and αi(2) for both types of games (p-val < 10−6, with KS distance of 0.25 and 0.23 for the gauging game and counting game, respectively). A contraction toward 0 occurs with a median going from 0.34 for αi(1) to 0.18 for αi(2) in the counting game and 0.32 to 0.20 in the gauging game (p-val< 10−15 for a paired one-sided Wilcoxon sign-rank test). In other words, the participants continue to be influenced after round 2 but this influence is lightened. Fig. 1-C shows the discrepancy between the cumulated distribution functions over rounds. Model Performance Prediction scenarios When one wishes to predict how a participant revises their opinion in a decision making process, the level of prediction accuracy will highly depend on data availability. More prior knowledge on the participant should improve the predictions. When little prior information is available about the participant, the influenceability derived from it will be unreliable and may lead to poor predictions. In this case, it may be more efficient to proceed to a classification procedure provided that data from other participants are available. These approaches are tested by computing the prediction accuracy in several situations reflecting data availability scenarios. In the worst case scenario, no data is available on the participant and the judgment revision mechanism is assumed to be unknown. In this case, predicting constant opinions over time is the only option. This corresponds to the null model against which the consensus model (1) is compared. In a second scenario, prior data from the same participant is available. The consensus model can then be fitted to the data (individual influenceability method). Data ranging from 1 to 15 prior instances of the judgment process are respectively used to learn how the participant revises their opinion. Predictions are assessed in each of these cases to test how the predictions are impacted by the amount of prior data available. In a final scenario, besides having access to prior data from the participant, it is assumed that a large body of participants took part in a comparable judgment making process. These additional data are expected to reveal the most common behaviours in the population and enable to derive typical influenceabilities by classification tools (population influenceability methods). For the population influenceability methods, there are two possibilities. First, assume that prior information on the participant is available. In this case, the influenceability class of the participant is determined using this information. In the alternative case, no prior data is available on the targeted participant. It is then impossible to discriminate which influenceability class they belong to. Instead, the most typical influenceability is computed for the entire population and the participant is predicted to follow this most typical behaviour. Prediction accuracy We assess the predictions when the number of training data is reduced, accounting for realistic settings where prior knowledge on individuals is scarce. Individual parameter estimation via the individual influenceability method is compared to population influenceability method. This last method uses one or two (α(1), α(2)) couples of values derived on independent experiments. Fig. 2 presents the RM SE (normalized to the range 0-100) obtained on validation sets for final round predictions using the model (1) with parameters fitted on training data of varying size. The methodology was also assessed for second round predictions instead of final round predictions. The results also hold in this alternative case, as described in Second round predictions section in Material and Methods. The individual influenceability and population influenceability methods are compared to a null model assuming constant opinion with no influence, i.e., α(r) = 0 (Null in Fig. 2). The null model does not depend on training set size. By contrast, the individual influenceability method which, for each individual, fits parameters αi(1) and αi(2) based on training data, is sensitive to training set size (Individual α in Fig. 2) : it performs better than the null model when the number of games used for training is higher than 5 in both types of games but its predictions become poorer otherwise, due to overfitting. Overfitting is alleviated using the population influenceability methods which restrict the choice of α(1) and α(2), making it robust to training size variations. The population method 5 (A) Gauging (B) Counting Figure 2. Root mean square error (RMSE) of the predictions for the final round. The RMSEs are obtained from crossvalidation. (A) gauging game, (B) counting game. In (B), the RM SE has been scaled by a factor of 5 to be comparable to the (A) plot. The bar chart displays crossvalidation errors for models that does not depend on the training size. Top blue horizontal line corresponds to the null model of constant opinion. The middle horizontal green line corresponds to fitting using the same typical couple of influenceability for the whole population. The bottom horizontal red line corresponds to the prediction error due to intrinsic variations in judgment revision. The decreasing black curve (triangle dots) corresponds to fitting with the individual influenceability method. The slightly decreasing orange curve (round dots) corresponds to fitting choosing among 2 typical couples of influenceability. All RM SE were obtained on validation games. The error bars provide 95% confidence intervals for the RMSEs. which uses only one typical couple of influenceability as predictor presents one important advantage. It provides a method which does not require any prior knowledge about the participant targeted for prediction. It is thus insensitive to training set size (Cons in Fig. 2). This method improves by 31% and 18% the prediction error for the two types of games compared 6 Individual past informationNullConsUnp151015RMSE5.3589101112Individual 2 typical Individual past informationNullConsUnp151015RMSE8.239101112Individual 2 typical to the null model of constant opinion. The population methods based on two or more typical couples of influenceability require to possess at least one previous game by the participant to calibrate the model (2 typical α in Fig. 2). These methods are more powerful than the former if enough data is available regarding the participant's past behaviour (2 or 3 previous games depending on the type of games). The number of typical couples of influenceabilities to use depends on the data availability regarding the targeted participant. This is illustrated in Fig. 3. The modification obtained using more typical influenceabilities for calibration is mild. Moreover, too many typical influenceabilities may lead to poorer predictions due to overfitting. This threshold is reached for 4 couples of influenceabilities in the gauging game data. As a consequence, it is advisable to restrict the choice to 2 or 3 couples of influenceabilities. This analysis shows that possessing data from previous participants in a similar task is often critical to obtain robust predictions on judgment revision of a new participant. (A) Gauging (B) Counting Figure 3. Predictive power of the consensus model when the number of typical couples of influenceability used for model calibration varies. Root mean square error (RMSE) plotted for training set size from 1 to 15 games. (A) gauging game, (B) counting game. In (B), RMSE has been scaled by a factor of 5 to be comparable to the (A) plot. The results of the control experiments are displayed by a red dashed line in Fig. 2-A,B. This bottom line corresponds to the amount of prediction error which is due to the intrinsic unpredictability of judgment revision. No model can make better predictions than this threshold (see Control experiment section in Material and Methods). The gauging game obtains an unpredictable RMSE of 5.35 while the counting game obtains 8.23. By contrast, the average square variation of the judgments between first and final rounds are respectively 11.76 and 11.84 for both types of games (corresponding to the RMSE of the null model). Taking the intrinsic unpredictable variation thresholds as a reference, the relative prediction RMSE is more than halved when using the time varying influenceability model (1) with one couple of typical influenceabilities instead of the null model with constant opinion. In other words, more than two thirds of the prediction error made by the consensus model is due to the intrinsic unpredictability of the decision revision process. The error bars in Fig. 2 provide 95% confidence intervals for the RMSEs. They confirms statistical significance of the difference between RMSEs. For clarity, the error bars are provided only for regression methods which do not depend on training set size. For completeness, supplementary Fig. S3 provides error bars for all models. RMSEs were used in this study since it corresponds to the quantity being minimized when computing the influenceability parameter α. Alternatively, reporting the Mean Absolute Errors (MAEs) may help the reader to obtain more intuition on the level of prediction error. For this reason, MAEs are provided in supplementary Fig. S4. Practical Implications of the Model Do groups reach consensus ? Because of social influence, groups tend to reduce their disagreement. However, this does not necessarily implies that groups reach consensus. To test how much disagreement remains after the social process, the distance between individual 7 Number of games for training2468101214RMSE7.582 typical (cid:1)3 typical (cid:1)4 typical (cid:1)Number of games for training2468101214RMSE8.592 typical (cid:1)3 typical (cid:1)4 typical (cid:1) judgments and mean judgments in corresponding groups is computed at each rounds. The results are presented for the gauging game. The same conclusions also hold for the counting game. Fig. 4 presents the statistics summary of these distances. The median distances are respectively 5.5, 4.2 and 3.5 for the three successive rounds, leading to a median distance reduction of 24% from round 1 to 2 and 16% from round 2 to 3. In other words, the contraction of opinion diversity is less important between rounds 2 and 3 than between rounds 1 and 2 and more than 50% of the initial opinion diversity is preserved at round 3. This is in accordance to the influenceability decay observed in Influenceability of participants section. If one goes a step further and assumes that the contraction continues to lessen at the same rate over rounds, it may be that groups will never reach consensus. This phenomenon is quite remarkable since it would explain the absence of consensus without requiring non-linearities in social influence. An experiment involving an important number of rounds would shed light on this question and is left for future work. Figure 4. Distance of participants' judgment to mean judgment for rounds 1, 2 and 3 in the gauging game. Is displayed only the data coming from games where for all 3 rounds at least 5 out of 6 participants provided a judgment. This ensures that the judgment mean and standard deviation can be compared over rounds. Influenceability and individual performance Each game is characterized by a true value, corresponding to an exact proportion to guess (for gauging games) or an exact amount of items displayed to the participants (for counting games). Whether social influence promotes or undermines individual performance can be measured for the two tasks. Individual performance can also be compared to the performance of the mean opinions in each group of 6 participants. At each round r, a participant's success is characterized by the root mean square distance to truth, denoted Ei(r). The error Ei(r) depicts how far a participant is to truth. Errors are normalized to fit in the range 0 − 100 in both types of tasks so as to be comparable. A global measure of individual errors is defined as the median over participants of Ei(r), and the success variation between two rounds is given by the median value of the differences Ei(r) − Ei(r + 1). A positive or negative success variation corresponds respectively to a success improvement or decline of the participants after social interaction. The errors are displayed in Fig. 5. The results are first reported for the gauging game. The median error Ei(r) for rounds 1, 2 and 3 are respectively 11.9, 10.0 and 9.8 (Fig. 5-(A)). It reveals an improvement with a success variation of 1.9 and 0.2 for Ei(1) − Ei(2) and Ei(2) − Ei(3) respectively (p-values< 10E − 5, sign test), showing that most of the improvement is made between first and second round. Regarding the counting game, the median error Ei(r) for rounds 1, 2 and 3 are respectively 23.1, 22.1 and 21.6 (Fig. 5-(B)). Note that the errors for the counting game have been rescaled by a factor of 5 to fit in the range 0 − 100. This corresponds to an improvement with a success 8 01020d = 5.5d = 4.2d = 3.5Distance to the mean (d)Round 1Round 2Round 3 variation of 1.0 and 0.5 for Ei(1) − Ei(2) and Ei(2) − Ei(3) respectively (the significance of the improvement is confirmed by a sign-test with p-values < 10E − 5). Fig. 5 also reports the aggregate performance in terms of the root mean square distance from mean opinions to truth in each group of 6 participants. Unlike individual performance, the median aggregate performance does not consistently improve. Regarding the gauging game, the median aggregate error is significantly higher in round 1 than in rounds 2 and 3 (p-val< 10E − 4, sign test) and this difference is not significant between rounds 2 and 3 (p-val> 0.05). Regarding the counting game, no significant difference is found among the 3 rounds for the median aggregate error (p-val> 0.05). As a consequence, social influence consistently helps the individual performance but does not consistently promote the aggregate performance. The reason why social influence helps the individual performance is a combination of two factors. First, at round 1, the mean opinion is closer to the truth than the individual opinion is (p-val< 0.01, Mann -- Whitney -- Wilcoxon test). Second, in accordance to the consensus model (1), individuals move closer to the mean opinion over subsequent rounds. The fact that initially the mean opinion is closer to truth than the individual opinions corresponds to the wisdom of the crowd effect. The wisdom of the crowd is a statistical effect stating that averaging over several independent judgments yields a more accurate evaluation than most of the individual judgments would (see the early ox experiment by Galton in 1907 [40] or more recent work [41]). Since the aggregate performance does not consistently improve over rounds, it can be said that social influence does not consistently promote the wisdom of the crowd. Lorenz et al. [4] say that social influence undermines the wisdom of the crowd because it "reduces the diversity of the group without improving its accuracy". This variance reduction is also observed in the present study and corroborates the consensus model (1). Interestingly, in the first round, the wisdom of the crowd effect is more prominent in the gauging game than in the counting game: the median individual error is 37% higher than the median error of the mean opinion in the gauging game while it is only 8% higher in the counting game. The reason for this difference is studied in details in supplementary section S2. (A) Gauging (B) Counting Figure 5. (A) gauging game; (B) counting game. From left to right : (Boxplot 1,3 and 5, in blue) Root mean square distance from individual opinions to truth (Ei(r)); (Boxplot 2,4 and 6 in red) Root mean square distance from mean opinion to truth. Values shown for the counting game have been scaled by a factor of 5. The fact that the mean opinion is more accurate than individual opinions leads to posit that participants using the mean opinion to form their own opinion, i.e., those with higher influenceability αi, will increase their performance. We examine relationships between success variation and the model parameters αi by computing partial Pearson correlations ρ controlling for the effect of the rest of the variables. Only significant Pearson correlations are mentioned (p-val < 0.05). All corresponding p-values happen to be smaller than 0.001 except for one as explicitly mentioned. Pearson correlations are given by pairs : the first value corresponds to 9 Round 1Round 2Round 302011.9109.89.27.98Distance to truthRound 1Round 2Round 302023.122.121.621.620.220.8Distance to truth the gauging game while the second to the counting game. Influenceability αi(1) between round 1 and 2 and improvement are positively related with ρ(αi(1), Ei(1) − Ei(2)) = 0.41/0.22. This is in accordance to the posited hypothesis. The wisdom of the crowd effect found at round 1 implies that participants who improve more from round 1 to 2 are those who give more weight to the average judgment. Since the wisdom of the crowd effect is more prominent in the gauging game than in the counting game, it is consistent that the correlation is higher in the former than in the latter. A similar effect relates success improvement and the influenceability αi(2) between round 2 and 3 with ρ(αi(2) , Ei(2) − Ei(3)) = 0.36/0.32. As may be expected, higher initial success leaves less room for improvement in subsequent rounds, which explains that ρ(Ei(1), Ei(1) − Ei(2)) = 0.68/0.21 and ρ(Ei(1), Ei(2) − Ei(3)) = 0.25/0.16 (where 0.16 is significant for p-val < 0.01). This also means that initially better participants are not better than average at using external judgments. Modelling influenceability across different types of games The assessment of the predictive power of model (1) on both types of games provides a generalisability test of the prediction method. The two types of games vary in difficulty. The root mean square relative distance Ei(1) between a participant's first round judgment and truth is taken as the measure of inaccuracy for each participant. The median inaccuracy for the counting game is 23.1 while it is 11.8 for the gauging game (Mood's median test supports the rejection of equal median, p = 0). Moreover, a Q-Q plot shows that inaccuracy is more dispersed for the counting game, suggesting that estimating quantities is more difficult than gauging proportion of colors. The accuracy of model (1) is compared for the two datasets in Fig. 2. Interestingly, the model prediction ranks remains largely unchanged for the two types of games. As depicted in Fig. 1-C, influenceability distributions do not vary significantly between the two games. A two-sample Kolmogorov-Smirnov test fails to reject the equality of distribution null hypothesis of equal median with p > 0.65 and a KS distance of 0.06 for both αi(1) and αi(2). This means that although the participants have an increased difficulty when facing the counting game, they do not significantly modify how much they take judgments from others into account. Additionally, the relationships between participants' success and influenceability are preserved for both types of games. The preserved tendencies corroborate the overall resemblance of behaviours across the two types of games. These similarities indicate that the model can be applied to various types of games with different level of difficulty. Conclusions The way online social systems are designed has an important effect on judgment outcome [42]. Operating or acting on these online social systems provides a way to significantly impact our markets, politics [43] and health. Understanding the social mechanisms underlying opinion revision is critical to plan successful interventions in social networks. It will help to promote the adoption of innovative behaviours (e.g., quit smocking [44], eat healthy) [45]. The design and validation of models of opinion revision will enable to create a bridge between system engineering and network science [46]. The present work shows that it is possible to model opinion evolution in the context of social influence in a predictive way. When the data regarding a new participant is available, parameters best representing their influenceability are derived using mean-square minimization. When the data is scarce, the data from previous participants is used to predict how the new participant will revise their judgments. To validate our method, results were compared for two types of games varying in difficulty. The model performs similarly in the two experiments, indicating that our influenceability model can be applied to other situations. The decaying influenceability model after being fit to the data suggests that despite opinion settlement, consensus will not be reached within groups and disagreement will remain. This suggests that there needs to be incentives for a group to reach a consensus. The analysis also reveals that participants who improve more are those with highest influenceability, this independently of their initial success. The degree to which one may successfully intervene on a social system is directly linked to the degree of predictability of opinion revision. Because there must always be factors which fall 10 out of the researcher's reach (changing mood or motivations of participants), part of the process cannot be predicted. The present study provides way to assess the level of unpredictability of an opinion revision mechanism. This assessment is based on a control experiment with hidden replicated tasks. The proposed experiment type and validation method can in principle be generalized to any sort of continuous judgment revision. The consensus model can also serve as a building block to more complex models when collective judgments rely on additional information exchange. Material and Methods Experiment Our research is based on an experimental website that we built, which received participants from a crowdsourcing platform. When a participant took part in an experiment, they joined a group of 6 participants. Their task was to successively play 30 games of the same sort related to 30 distinct pictures. Criteria for online judgment revision game The games were designed to reveal how opinions evolve as a result of online social influence. Suitable games have to satisfy several constraints. First, to finely quantify influence, the games ought to allow the evolution of opinion to be gradual. Numbers were chosen as the way for participant to communicate their opinion. Multiple choice questions with a list of unordered items (e.g., choosing among a list of holiday locations) were discarded. Along the same lines, the evolution of opinion requires uncertainty and diversity of a sufficient magnitude in the initial judgments. The games were chosen to be sufficiently difficult to obtain this diversity. Thirdly, to encourage serious behaviours, the participants were rewarded based on their success in the games. This required the accuracy of a participant to be computable. Games were selected to have an ideal opinion or truth which served as a reference. Subjective questions involving for instance political or religious opinions were discarded. Additionally, the game had to satisfy two other constraints related to the online context where, unlike face-to-face experiments, the researcher cannot control behavioural trustworthiness. Since the educational and cultural background of participants is a priori unknown, the game had to be accessible, i.e., any person which could read English had to be able to understand and complete the game. As a result, the games had to be as simple as possible. For instance, games could not involve high-level mathematical computations. Despite being simple to understand our games were still quite difficult to solve, in accordance with the first constraint. Lastly, to anticipate the temptation to cheat, the solution to the games had to be absent from the Internet. Therefore, questions such as estimating the population of a country were discarded. Gauging and counting games Each game was associated with a picture. In the gauging game, the pictures were composed of 3 colors and participants estimated the percentage as a number between 0 and 100 of the same given color in the picture. In the counting game, the picture was composed of between 200 and 500 many small items, so that the participant could not count the items one by one. The participants had then to evaluate the total number of these items as a number between 0 and 500. A game was composed of 3 rounds. The picture was kept the same for all 3 rounds. In each round, the participant had to make a judgment. During the first round, each of the 6 participants provided their judgment, independently of the other participants. During the second round, each participant anonymously received all other judgments from the first round and provided their judgment again. The third round was a repetition of the second one. Accuracy of all judgments were converted to a monetary bonus to encourage participants to improve their judgment at each round. Screenshots of the games' interface are provided in the Design of the Experiment section. Design of the experiment The present section describes the experiment interface. A freely accessible single player version of the games was also developed to provide a first hand experience of the games. In the single player version, participants are exposed to judgments 11 stored on our database obtained from real participant in previous games. The single player version is freely accessible at http://collective-intelligence.cran.univ-lorraine.fr/eg/login. The interface and the timing of the single player version is the same as the version used in the control experiment. The only difference is that the freely accessible version does not involve redundant games and provides accuracy feedback to the participants. In the multi-player version which was used for the uncontrolled experiment, the participants came from the CrowdFlower® external crowdsourcing platform where they received the URL of the experiment login page along with a keycode to be able to login. The ad we posted on CrowdFlower was as follows : Estimation game regarding color features in images You will be making estimations about features in images. Beware that this game is a 6-player game. If not enough people access the game, you will not be able to start and get rewarded. To start the game : click on <estimation-game> and login using the following information : login : XXXXXXXX password: XXXXXXXX You will receive detailed instruction there. At the end of the game you will receive a reward code which you must enter below in order to get rewarded : < > The participants were told they will be given another keycode at the end of the experiment which they had to use to get rewarded on the crowdsourcing platform, this forced the participants to finish the experiment if they wanted to obtain a payment. Secondly, the participants arrived on the experiment login page, chose a login name and password so they could come back using the same login name if they wanted to for another experiment (see supplementary Fig. S5). Once they had logged in, they were requested to agree on a consent form mentioning the preservation of the anonymity of the data (see the Consent and privacy section below for details). Thirdly, the participants were taken to a questionnaire regarding personality, gender, highest level of education, and whether they were native English speaker or not (all the experiment was written in English). The questions regarding personality come from a piece of work by Gosling and Rentfrow [39] and were used to estimate the five general personality traits. The questionnaire page is reported in supplementary Fig. S6. Once the questionnaire submitted, the participants have access to the detailed instructions on the judgment process (supplementary supplementary Fig. S7). After this step, they were taken to a waiting room until 6 participants had arrived at this step. At this point, they started the series of 30 games which appeared 3 at a time, with one lone round where they had to make judgments alone and two social rounds where the provided judgment being aware of judgments from others. An instance of the lone round is given in supplementary Fig. S8-(A) for the counting game while a social round is shown in supplementary Fig. S9. Instances of pictures for the gauging game are provided in supplementary Fig. S8-(B). In the gauging game, the question was replaced by "What percentage of the following color do you see in the image ?". For this type of games, a sample of the color to be gauged for each pictures was displayed between the question and the 3 pictures. At the end of the 30 games, the participants had access to a debrief page where was given the final score and the corresponding bonus. They could also provide a feedback in a text box. They had to provide their email address if they wanted to obtain the bonus (see supplementary Fig. S10). Consent and privacy Before starting the experiment, participants had to agree electroni- cally on a consent form mentioning the preservation of the anonymity of the data : Hello! Thank you for participating in this experiment. You will be making estima- tions about features in images. The closer your answers are to the correct answer, the higher reward you will receive. Your answers will be used for research on per- sonality and behaviour in groups. We will keep complete anonymity of participants at all time. If you consent you will first be taken to a questionnaire. Then, you will get to a detailed instruction page you should read over before starting the game. Do you understand and consent to the terms of the experiment explained above ? If so click on I agree below. 12 In this way, participants were aware that the data collected from their participation were to be be used for research on personality and behaviour in groups. IP addresses were collected. Email addresses were asked. Email addresses were only used to send participants bonuses via Paypal® according to their score in the experiments. IP addresses were used solely to obtained the country of origin of the participants. Behaviours were analyzed anonymously. Information collected on the participants were not used in any other way than the one presented in the manuscript and were not distributed to any third party. Personality, gender and country of origin presented no correlation with influenceability or any other quantity reported in the manuscript. The age of participants was not collected. Only adults are allowed to carry out microtasks on the CrowdFlower platform : CrowdFlower terms and conditions include : "you are at least 18 years of age". The experiment was declared to the Belgian Privacy Comission (https://www.privacycommission.be/) as requested by law. The French INSERM IRB read the consent procedure and confirmed that their approval was not required for this study since the data were analyzed anonymously. Control experiment Human judgment is such a complex process that no model can take all its influencing factors into account. The precision of the predictions is limited by the intrinsic variation in the human judgment process. To represent this degree of unpredictability, we consider the variation in the judgment revision process that would occur if a participant were exposed to two replicated games in which the set of initial judgments happened to be identical. A control experiment served to measure this degree of unpredictability. To create replicated experimental conditions, the judgments of five out of the six partic- ipants were synthetically designed. The only human participant in the group was not made aware of this, so they would act as in the uncontrolled experiments. Practically, partici- pants took part in 30 games, among these, 20 games had been designed to form 10 pairs of replicated games with an identical picture used in both games of a pair. To make sure the participants did not notice the presence of replicates, the remaining 10 games were distributed between the replicates. The order of appearance of the games with replicates is as follows : 1, 2, 113, 4, 126, 13, 514, 7, 89, 1, 154, 10, 162, 6, 177, 18, 38, 5, 1910, 9, 20, where games 1 to 10 are the replicated games. The games successively appeared three at a time from left to right. The 15 synthetic judgments (5 participants over 3 rounds) which appeared in the first instance of a pair of replicates were copies of past judgment made by real participants in past uncontrolled experiments. The copied games collected in uncontrolled experiments were randomly selected among the games in which more than 5 participants had provided judgments. Since the initial judgment of the real participant could not be controlled, the 15 synthetic judgments in the second replicate had to be shifted in order to maintain constant the initial judgment distances in each replicate. The shift was computed in real time to match the variation of the real participant initial judgments between the two replicates. The same shift was applied to all rounds to keep the synthetic judgments consistent over rounds (see Fig. 6 for the illustration of the shifting process). This provided exactly the same set of initial judgments up to a constant shift in each pair of replicated games. Such an experimental setting allowed assessing the degree of unpredictability in judgment revision (see the Prediction accuracy section in Results for details). Participants Uncontrolled experiment The data were collected during July, September and October 2014. Overall, 654 distinct participants took part in the study (310 in the gauging game only, 308 in the counting game only and 36 in both). In total, 64 groups of 6 participants completed a gauging game, while 71 groups of 6 participants completed a counting game. According to their IP addresses, participants came from 70 distinct countries. Participants mostly originated from 3 continents : 1/3 from Asia, 1/2 from Europe and 1/6 from South America. As detailed at the end of the paragraph, most participants completed most of the 30 games and played trustworthfully. The others were ignored from the study via two systematic filters. First, since the prediction method was tested using up to 15 games in the model parameter estimation process, the predictions reported in present study concern only the participants who completed more than 15 out of the 30 games. This ensures that the number of games used for parameter 13 Figure 6. Illustration of the shift applied to the synthetic judgment in order to preserve the distances between initial judgments. The shift made by the participant in the first round was synthetically applied to all other initial judgments. The intrinsic variation in judgment revision is the distance between second round judgments, reduced by the shift in initial judgments. The dotted cross is not a judgment and is only displayed to show how the second round intrinsic variation is computed using the initial shift. All shifts are equal. The same shift is also applied to all other second round judgments, and used to compute final round intrinsic variations. estimations is homogeneous over all participants. The prediction performance can then be compared among participants. The median number of fully completed games per participants was 24 with 10.5 std for the gauging game and 27 with 10.5 std for the counting game. Lower numbers are possibly due to loss of interest in the task or connexion issues. The first filter lead to keep 68% of the participants for the gauging game and 71% for the counting game (see Fig. 7 -- A,C for details). Secondly, the prediction were only made on judgments of trustworthy participants. Trustworthiness was computed via correlation between participant's judgments and true answers. Most participants carried out the task truthworthfully with a median correlation of 0.85 and median absolute deviation (MAD) of 0.09 for the gauging game and 0.70 median and 0.09 MAD for the counting game. A few participants either played randomly or systematically entered the same aberrant judgment. A minimum Pearson correlation thresholds of 0.61 for the gauging game and 0.24 for the counting game were determined using Iglewicz and Hoaglin method based on median absolute deviation [47]. The difference between the two thresholds is due to the higher difficulty of the counting game as expressed by the difference between median correlations. This lead to keep 91% and 96% of the participants which had passed the first filter (see Fig. 7 -- B,D for details). It should be acknowledged that the selection procedure may have lead to sample bias. This could be due to self-selection : some people choose to participate in the experiment and others do not. The fact that the study was carried out online is another factor that could bias the sample. The a posteriori filters may be another source of bias. These are common issues in the behavioural sciences. Possibly, the nature of the study will have appealed to certain types of people and not others. Although that could have biased the characteristics of the sample, we are unaware of any empirical evidence suggesting that people who like participating in this kind of tasks are more or less susceptible to social influence. Control experiment The data were collected during May and June 2015. Overall, 207 distinct participants took part in the study (113 in the gauging game only, 87 in the counting game only and 7 in both). The 120 gauging game participants took part in 139 independent games while the 94 counting game participants were involved in 99 independent games. Each independent game was completed by 5 synthetic participants to form groups of 6. The same filters as those used in the uncontrolled experiment were applied to the participants in the 14 Round 1original gameRound 1 duplicated gameffVirtual playersReal player00100100opinion spaceopinion spaceshift0100opinion spaceshift0100opinion spaceshiftintrinsicnoiseRound 2original gameRound 2 duplicated game (A) Gauging (B) Counting (C) Gauging (D) Counting Figure 7. Filters for participants' trustworthiness. (A),(C) gauging game, (B),(D) counting game. (A,B) : Histograms of the number of full games played by participants. (C,D) : Histograms of the correlations between judgments and true values for each participant. Rejected participants are displayed in red while kept participants are in blue, to the right of the black arrow. control experiment. This lead to keep 88% of the counting games and 80% of the gauging games. Opinion revision model To capture the way individual opinions evolve during a collective judgment process, a consensus model is used. These models have a long history in social science [38] and their behaviour has been thoroughly analyzed in a theoretical way [48,49]. Our model (1) assumes that when an individual sees a set of opinions, their opinion changes linearly in the distance between their opinion and the mean of the group opinions. There is recent evidence supporting this assumption [7]. See also supplementary section S3 for a test of the validity of the linearity assumption. The rate of opinion change as a result of social influence is termed the influenceability of a participant. The model also assumes that this influenceability may vary over time. The decrease of influenceability represents opinion settling. The model is described in mathematical terms in equation (1), with αi(r) being the influenceability of participant i after round r. When αi(1) is nonzero, the ratio αi(2)/αi(1) represents the decaying rate of influenceability. Parameters αi(1) and αi(2) are to be estimated to fit the model to the data. It is expected that 15 051015202530020406080100120Full games playedPlayers050100150510152025300Full games playedPlayers00.610204060Pearson correlation coefficientPlayers00.20.61010203040Pearson correlation coefficientPlayers αi(1), αi(2) ∈ [0, 1]. If αi(r) = 0, the participant does not take into account the others and their opinion remains constant. If αi(r + 1) = αi(r), the influenceability does not change in time and the opinion xi(t) eventually converges to the mean opinion ¯x. Instead, if αi(r + 1)/αi(r) < 1, influenceability starts positive but decays over time, which represents opinion settling. There exist several variations to the linear consensus model presented above. In particular, the bounded confidence models [50,51] assume that the influenceability αi(t) also depends on the distance between one's opinion and the influencing opinion. Alternatively, the model by Friedkin and Johnsen [52] assumes that individuals always remain influenced by their initial opinion or prejudice over time. Rather than providing an exhaustive assessment of the alternative models found in the literature, the objective of the present study is to show how the predictive power of a simple model of opinion dynamics can be assessed and to estimate the minimal prediction error that one can expect for any opinion dynamics model. Consensus models of opinion dynamics are well adapted to represent opinions evolving in a continuous space. This corresponds to many real world situations in which the opinion represents the inclinaison between two extreme opposite options such as left and right in politics. Alternatively, part of the literature consider models with binary choices or actions (e.g., voting for one candidates, buying a car or going on strikes). These discrete choice models include the rumour [53] and threshold models [54, 55]. In the latter, an individual changes their action when a certain proportion of its neighbours does so. These models directly link the discrete action of an individual to the actions in their neighbourhood. This allows to describe cascade propagation of behaviours. Presumably, before someone changes their actions, their opinion had to change as a result of the social stimuli. A recent model bridges these two bulks of work, considering the social influence of discrete actions on continuous opinions (the CODA model) which itself results in an individual action [56]. It appears that this model also naturally leads to cascade of behaviours over a social network [57]. It would be interesting to see how the threshold parameter in Granovetter's model may be expressed in terms of the initial opinion of individual in the CODA model : individuals with an opinion close to the boundary leading to either of the two discrete actions would have a lower threshold for action change. The past two decades have witnessed a few attempts to confront simple models of opinion dynamics to real world data on collective human behaviours. These include conflicts and controversies on Wikipedia [58,59] or how voters distribute their votes among candidates in elections [60 -- 62]. However, since individual opinions involved in real world processes are not directly available, researchers had to calibrate their models on global measures such as level of controversy or distribution of votes. Moreover, the predictive power of these models was not assessed : the data used to calibrate the models also served to validate them. In vitro studies such as the present one have the advantage of providing the micro-level data driving the collective dynamics. Another advantage of in vitro studies is the possibility to differentiate social influence from other confounding factors such as homophily thanks to the anonymity of influencing individuals (see also [63,64]). Prediction procedure Regression procedure The goal of the procedure is to predict the future judgment of a given participant in a given game. The set of first round judgments of this game are supposed to be known to initialize the model (1), this includes the initial judgment from the participant targeted for prediction and the initial judgments from the five other participants who possibly influenced the former. To tune the model, prior games from the same participant are assumed to be available. These data serve to estimate the influenceability parameters αi(1) and αi(2). In one scenario, the influenceability parameters of the participant are estimated independently of the data from other participants (individual influenceability method). This is the only feasible method when no prior data on other participants is available (see the Prediction scenarios section in Results for details on the data availability scenarios). In this first case, parameters αi(1) and αi(2) are determined using a mean square error minimization procedure (this procedure amounts to likelihood maximization when the errors between model predictions and actual judgments are normally distributed and have zero mean, see for instance [65, p27]). In situations where the number of prior games available to estimate the influenceability 16 parameters is small, little information is available on the participant's past behaviour. This may result in unreliable parameter estimates. To cope with such situations, another scenario is considered : besides having access to prior data from the targeted participant, part of the remaining participants (half of them, in our study) are used to derive the typical influenceabilities in the population. The expectation-maximization (EM) algorithm is used to classify the population into groups of similar influenceabilities [65]. These typical influenceabilities serve as a pool of candidates. The prior games of the targeted participant are used to determine which candidate yields the smallest mean square error (population influenceability method). The procedure to determine which typical candidate best suits a participant requires less knowledge than the one to accurately estimate their influenceability without a prior knowledge on its value (see the results in the Prediction accuracy section in Results). Validation procedure The three scenarios presented in the Prediction scenarios section in Results are validated via crossvalidation. The validation procedure of the last scenario (i.e., access to prior data from participants, existence and access to typical influenceabilities) starts by randomly splitting the set of participants into two equal parts. The prediction focuses on one of the two halves while the remaining half is used to derive the typical influenceabilities in the population influenceability method. In the half serving for prediction, our model is assessed via repeated random sub-sampling crossvalidation : for each participant, a training subset of the games is used to assign the appropriate typical influenceabilities to each participant. The rest of the games serves as the validation set to compute the root mean square error (RMSE) between the observed data and predictions. The error specific to participant i is denoted as RM SEi. The results are compared for various training set sizes. The RMSE is obtained from averaging errors over 300 iterations using a different randomly selected training set each time. To compare scenarios 1 and 2 with scenario 3, we only consider the half serving for prediction. Scenario 1 (no data available) does not require any training step. For scenario 2 (access to prior data from participants), instead of learning affectation of typical influenceabilities to each participant, the learning process directly estimates the influenceabilities αi(1) and αi(2) for each participant without prior assumption on their values. The whole validation process is also carried out reversing the role of the two halves of the population and a global RMSE is computed out of the entire process. Intrinsic unpredictability estimation Unpredictability of the second round judgment Even though the study mainly focuses on the predictions of third round judgments, we first focus in the present section on the two first rounds of the games, for the sake of clarity. The prediction procedure can easily be adapted to predict second round rather than third round judgments. Results for second round predictions based on the consensus model (1) are presented in Second round predictions section below. The control experiment described in Control experiment section provides a way of estimating the intrinsic variations in the human judgment process. When a participant takes part in a game, their actual second judgment depends on several factors : their own initial judgment xi(1), the vector of initial judgments from other participants denoted as xothers(1) and the displayed picture. As a consequence, the second round judgment of a participant can always be written as xi(2) = f 1 i (xi(1), xothers(1), picture) + η, (2) i describes how a participant revises their judgment in average depending on their where f 1 initial judgment and external factors. The term picture is the influence of the picture on the final judgment. The quantity η captures the intrinsic variation made by a participant when making their second round judgment despite having made the same initial judgment and being exposed to the same set of judgments and identical picture. Formally η is a random variable with zero mean. This is shown in supplementary section S1.1. The standard deviation of η is assumed to be the same for all participants to the same game, denoted as std(η). The standard deviation std(η) measures the root mean square error between f i and the actual judgment 1 xi(2) ; this error measures by definition the intrinsic unpredictability of the judgment revision i would provide the best prediction regarding judgment process. If it was known, the function f 1 17 is unknown, but revision. By definition, no other model can be more precise. The function f 1 i it is reasonable to make the following assumptions. First, the function f is assumed to be a 1 i sum of (i) the influence of the initial judgments and and (ii) the influence of the picture. Thus i splits into two components : 1 f 1 i (xi(1), xothers(1), picture) = f i (xi(1), xothers(1)) + (1 − λ)h 1 1 i (picture), λg where g i represents the dependence of the second round judgment on past judgments while h 1 1 i contains the dependency regarding the picture. The parameter λ ∈ [0, 1] weights the relative importance of the first term compared to the second and is considered unique for each particular type of game. It is further assumed that if the initial judgment xi(1) and the others judgment at round 1 are shifted by a constant shift, the g i component in the second round judgment will 1 on average be shifted in the same way, in other words, it is possible to write 1 i (xi(1) + s, xothers(1) + s) = g g 1 i (xi(1), xothers(1)) + s, where s is a constant shift applied to the judgments. Under this assumption, the control experiment provides a way of measuring the intrinsic variation. The intrinsic variation estimation std(η) can be empirically measured as the root mean of 1 2(x i(2) − xi(2) − λ(x 0 i(1) − xi(1)))2 0 (3) over all repeated games and all participants, where the prime notation is taken for judgments from the second replicated game in the control experiment (see Participants section in Material and Methods. The derivation of equation (3) is provided in supplementary section S4. Since η is assumed to have zero mean, the function fi properly describing the actual judgment revision process is the one minimizing std(η). Correspondingly, the constant λ ∈ [0, 1] is set so as to satisfy this minimization. The intrinsic variation estimation std(η) is displayed in Fig. 8. The optimal λ values are found to be 0.67 and 0.74 and correspond to intrinsic unpredictability estimations of 5.38 and 7.36 for the gauging game and the counting game, respectively. These thresholds can be used to assess the quality of the predictions for the second round (see Second round predictions section). Unpredictability of the final round judgment The procedure to estimate third round intrinsic unpredictability, whose results are shown in Fig. 2, varies slightly from second round estimation procedure. For third round judgments, a function with the same input as f i , 1 depending only on the initial judgments and the picture, cannot properly describe the judgment revision of one participant independently of the other participant's behaviour. In fact, the third round judgments depend on the second round judgments of others, which results from the revision process of other players. In other words, in a situation where a participant were to be faced successively to two groups of other participants, who by chance had given an identical set of initial judgments, the second round judgments of the two groups could vary due to distinct ways of revising their judgments. Since the initial judgments does not suffice in describing third round judgments, function is modified to take the second round judgments of others xothers(2) as an additional input. 1 f i Then, the control experiment provides a way to estimate the intrinsic variations occurring in judgment revision up to the third round. This is described formally in the rest of the section. However, it should be noted that this description of judgment revision does not strictly speaking provide the exact degree of intrinsic variation included in the final round prediction error made in the uncontrolled experiment, it is rather an under-estimation of it : The predictions via the consensus model presented in the Prediction performance section in Results, are based solely on the initial judgments, whereas, the second round judgment from other participants are also provided in the present description. This additional piece of information necessarily makes the description of third round judgment more precise. As a consequence, the intrinsic variation estimated here (see details below) is an under-estimation of the actual intrinsic variation included in the prediction error of the consensus model. From a practical point of view, this means that the actual intrinsic unpredictability threshold is actually even closer to the predictions made 18 (A) Gauging (B) Counting (C) Gauging (D) Counting Figure 8. Root mean square intrinsic variation as a function of the λ param- eters. (A), (B) : the second round judgments, as given in equation (3). (C), (D) : the third round judgments, as given in equation (5). (A), (C) gauging game, (B), (D) counting game. by the consensus model than displayed in Fig. 2. In other words, there is even less space to improve the predictions provided by the consensus model, since more than two thirds of the error comes from the intrinsic variation rather than from the model imperfections. Formally, the deterministic part of the third round judgment of a participant xi(3) is fully determined as a function of their initial judgment xi(1), the initial judgment of others xothers(1), the second round judgment of others xothers(2) and the picture. So, the third round judgment can be written as xi(3) = f 2 i (xi(1), xothers(1), xothers(2), picture) + ¯η, (4) where ¯η is the estimation of the intrinsic variation occurring after three rounds under the same initial judgments, same picture and same second round judgments from others. Under the same assumptions on function f i , and analogously to equation (3), std(¯η) is 1 measured by the root mean of 1 2(x i as those made on f 2 i(3) − xi(3) − λ(x 0 i(1) − xi(1)))2 0 (5) over all repeated games and all participants. This intrinsic variation is provided as a function of parameter λ in Fig. 8, (C)-(D). Second round predictions The prediction procedure based on the consensus model (1) is applied to predict the second round judgments. Crossvalidation allows to assess the accuracy of the model. Results are presented in Fig. 9. These results are qualitatively equivalent to the prediction errors for the third round as shown in Fig. 2, although the second round predictions lead to a lower RMSEs, as expected since they correspond to shorter term predictions. 19 (cid:1)00.67155.388(cid:1)00.7417.3691300.64155.358λ00.718.23913λ (A) Gauging (B) Counting Figure 9. Root mean square error (RMSE) of the predictions for the second round. The RMSEs are obtained from crossvalidation. (A) gauging game, (B) counting game. In (B), the RM SE has been scaled by a factor of 5 to be comparable to the (A) plot. The bar chart displays crossvalidation errors for models that does not depend on the training set size. Top blue horizontal line corresponds to the null model of constant opinion. The middle horizontal green line correspond to fitting using the same typical couple of influenceability for the whole population. The bottom horizontal red line correspond to the prediction error due to intrinsic variations in judgment revision. The decreasing black curves (triangle dots) correspond to fitting with the individual influenceability method. The slightly decreasing orange curves (round dots) correspond to fitting choosing among 2 typical couples of influenceability. All RM SE were obtained on validation games. Acknowledgments C. V. K. is a F.N.R.S./FRIA research fellow. Research partly supported by the Belgian Interuniversity Attraction Poles (Dynamical systems, control and optimization network), by 20 Individual past informationNullConsUnp151015RMSE5.38789101112Individual 2 typical Individual past informationNullConsUnp151015RMSE7.36891011Individual 2 typical REFERENCES REFERENCES an Actions incitatives 2014 of the Centre de Recherche en Automatique de Nancy, by project Modélisation des dynamiques dans les réseaux d'échange de semences (PEPS MADRES) funded by the Centre National pour la Recherche Scientifique and project Computation Aware Control Systems (COMPACS), ANR-13-BS03-004 funded by the Agence National pour la Recherche. Contact : [email protected]. The funders had no role in study design, data collection and analysis, decision to publish, or preparation of the manuscript. Author contributions statement C. V. K., S. M., J. M. H., P. J. R. and V. D. B. conceived the experiment(s). C. V. K., S. M. and P. G. conducted the experiments. C. V. K. and S. M. analysed the results. All authors reviewed the manuscript. Additional information Competing financial interests: The authors declare no competing financial interests. References 1. Centola D. The spread of behavior in an online social network experiment. science. 2010;329(5996):1194 -- 1197. 2. Aral S, Walker D. Identifying influential and susceptible members of social networks. Science. 2012;337(6092):337 -- 341. 3. Salganik MJ, Dodds PS, Watts DJ. Experimental study of inequality and unpredictability in an artificial cultural market. Science. 2006;311(5762):854 -- 856. 4. Lorenz J, Rauhut H, Schweitzer F, Helbing D. How social influence can undermine the wis- dom of crowd effect. Proceedings of the National Academy of Sciences. 2011;108(22):9020 -- 9025. 5. Moussaïd M, Kämmer JE, Analytis PP, Neth H. Social influence and the collective dynamics of opinion formation. PloS one. 2013;8(11):e78433. 6. Chacoma A, Zanette DH. Opinion Formation by Social Influence: From Experiments to Modeling. PloS one. 2015;10(10):e0140406. 7. Mavrodiev P, Tessone CJ, Schweitzer F. Quantifying the effects of social influence. Scientific reports. 2013;3. 8. Hastie R, Penrod S, Pennington N. Inside the jury. The Lawbook Exchange, Ltd.; 1983. 9. Horowitz IA, ForsterLee L, Brolly I. Effects of trial complexity on decision making. Journal of applied psychology. 1996;81(6):757. 10. Hinsz VB, Indahl KE. Assimilation to Anchors for Damage Awards in a Mock Civil Trial1. Journal of Applied Social Psychology. 1995;25(11):991 -- 1026. 11. Fischer I, Harvey N. Combining forecasts: What information do judges need to outperform the simple average? International journal of forecasting. 1999;15(3):227 -- 246. 12. Harvey N, Harries C, Fischer I. Using advice and assessing its quality. Organizational behavior and human decision processes. 2000;81(2):252 -- 273. 13. Schrah GE, Dalal RS, Sniezek JA. No decision-maker is an Island: integrating expert advice with information acquisition. Journal of Behavioral Decision Making. 2006;19(1):43 -- 60. 14. Sniezek JA, Schrah GE, Dalal RS. Improving judgement with prepaid expert advice. Journal of Behavioral Decision Making. 2004;17(3):173 -- 190. 15. Budescu DV, Rantilla AK. Confidence in aggregation of expert opinions. Acta psycho- logica. 2000;104(3):371 -- 398. 21 REFERENCES REFERENCES 16. Budescu DV, Rantilla AK, Yu HT, Karelitz TM. The effects of asymmetry among advisors on the aggregation of their opinions. Organizational Behavior and Human Decision Processes. 2003;90(1):178 -- 194. 17. Harvey N, Fischer I. Taking advice: Accepting help, improving judgment, and sharing responsibility. Organizational Behavior and Human Decision Processes. 1997;70(2):117 -- 133. 18. Harries C, Yaniv I, Harvey N. Combining advice: The weight of a dissenting opinion in the consensus. Journal of Behavioral Decision Making. 2004;17(5):333 -- 348. 19. Yaniv I. The benefit of additional opinions. Current directions in psychological science. 2004;13(2):75 -- 78. 20. Yaniv I. Receiving other people's advice: Influence and benefit. Organizational Behavior and Human Decision Processes. 2004;93(1):1 -- 13. 21. Gino F. Do we listen to advice just because we paid for it? The impact of advice cost on its use. Organizational Behavior and Human Decision Processes. 2008;107(2):234 -- 245. 22. Yaniv I, Milyavsky M. Using advice from multiple sources to revise and improve judgments. Organizational Behavior and Human Decision Processes. 2007;103(1):104 -- 120. 23. Bonaccio S, Dalal RS. Advice taking and decision-making: An integrative literature review, and implications for the organizational sciences. Organizational Behavior and Human Decision Processes. 2006;101(2):127 -- 151. 24. Yaniv I, Kleinberger E. Advice taking in decision making: Egocentric discounting and rep- utation formation. Organizational behavior and human decision processes. 2000;83(2):260 -- 281. 25. Soll JB, Larrick RP. Strategies for revising judgment: How (and how well) people use others' opinions. Journal of Experimental Psychology: Learning, Memory, and Cognition. 2009;35(3):780. 26. Feng B, MacGeorge EL. Predicting receptiveness to advice: Characteristics of the problem, the advice-giver, and the recipient. Southern Communication Journal. 2006;71(1):67 -- 85. 27. See KE, Morrison EW, Rothman NB, Soll JB. The detrimental effects of power on confidence, advice taking, and accuracy. Organizational Behavior and Human Decision Processes. 2011;116(2):272 -- 285. 28. Gino F, Schweitzer ME. Blinded by anger or feeling the love: how emotions influence advice taking. Journal of Applied Psychology. 2008;93(5):1165. 29. Mannes AE. Are we wise about the wisdom of crowds? The use of group judgments in belief revision. Management Science. 2009;55(8):1267 -- 1279. 30. Azen R, Budescu DV. The dominance analysis approach for comparing predictors in multiple regression. Psychological methods. 2003;8(2):129. 31. Pope DG. Reacting to rankings: evidence from "America's Best Hospitals". Journal of health economics. 2009;28(6):1154 -- 1165. 32. Dellarocas C. The digitization of word of mouth: Promise and challenges of online feedback mechanisms. Management science. 2003;49(10):1407 -- 1424. 33. Bessi A, Coletto M, Davidescu GA, Scala A, Caldarelli G, Quattrociocchi W. Science vs Conspiracy: collective narratives in the age of misinformation. PloS one. 2015;10(2):02. 34. Steyvers M, Griffiths TL, Dennis S. Probabilistic inference in human semantic memory. Trends in Cognitive Sciences. 2006;10(7):327 -- 334. 35. Kersten D, Yuille A. Bayesian models of object perception. Current opinion in neurobiol- ogy. 2003;13(2):150 -- 158. 36. Ma WJ, Beck JM, Latham PE, Pouget A. Bayesian inference with probabilistic population codes. Nature neuroscience. 2006;9(11):1432 -- 1438. 37. Vul E, Pashler H. Measuring the crowd within probabilistic representations within individuals. Psychological Science. 2008;19(7):645 -- 647. 22 REFERENCES REFERENCES 38. French J. A formal theory of social power. Psychological Review. 1956;63:181 -- 194. 39. Gosling SD, Rentfrow PJ, Swann WB. A very brief measure of the Big-Five personality domains. Journal of Research in personality. 2003;37(6):504 -- 528. 40. Galton F. Vox populi (the wisdom of crowds). Nature. 1907;75:450 -- 451. 41. Ariely D, Tung Au W, Bender RH, Budescu DV, Dietz CB, Gu H, et al. The effects of averaging subjective probability estimates between and within judges. Journal of Experimental Psychology: Applied. 2000;6(2):130. 42. Muchnik L, Aral S, Taylor SJ. Social influence bias: A randomized experiment. Science. 2013;341(6146):647 -- 651. 43. Bond RM, Fariss CJ, Jones JJ, Kramer AD, Marlow C, Settle JE, et al. A 61- influence and political mobilization. Nature. million-person experiment in social 2012;489(7415):295 -- 298. 44. Christakis NA, Fowler JH. The Collective Dynamics of Smoking in a Large Social Network. New England Journal of Medicine. 2008;358(21):2249 -- 2258. PMID: 18499567. 45. Valente TW. Network interventions. Science. 2012;337(6090):49 -- 53. 46. Liu YY, Slotine JJ, Barabási AL. Controllability of complex networks. Nature. 2011;473(7346):167 -- 173. 47. Iglewicz B, Hoaglin DC. How to detect and handle outliers. vol. 16. ASQC Quality Press Milwaukee (Wisconsin); 1993. 48. Olfati-Saber R, Fax JA, Murray RM. Consensus and cooperation in networked multi-agent systems. Proceedings of the IEEE. 2007;95(1):215 -- 233. 49. Martin S, Girard A. Continuous-time consensus under persistent connectivity and slow divergence of reciprocal interaction weights. SIAM Journal on Control and Optimization. 2013;51(3):2568 -- 2584. 50. Deffuant G, Neau D, Amblard F, Weisbuch G. Mixing beliefs among interacting agents. Advances in Complex Systems. 2000;3(1 -- 4):87 -- 98. 51. Hegselmann R, Krause U. Opinion dynamics and bounded confidence models, analysis, and simulation. Journal of Artificial Societies and Social Simulation. 2002;5(3). 52. Friedkin NE, Johnsen EC. Social influence and opinions. Journal of Mathematical Sociology. 1990;15(3-4):193 -- 206. 53. Dodds PS, Watts DJ. Universal behavior in a generalized model of contagion. Physical review letters. 2004;92(21):218701. 54. Granovetter M. Threshold models of collective behavior. American Journal of Sociology. 1978;83:1420 -- 1443. 55. Watts DJ. A simple model of global cascades on random networks. Proceedings of the National Academy of Sciences. 2002;99(9):5766 -- 5771. 56. Martins AC. Continuous opinions and discrete actions in opinion dynamics problems. International Journal of Modern Physics C. 2008;19(04):617 -- 624. 57. Chowdhury N, Morarescu IC, Martin S, Srikant S. Continuous opinions and discrete actions in social networks: a multi-agent system approach. arXiv preprint arXiv:160202098. 2016;. 58. Iñiguez G, Török J, Yasseri T, Kaski K, Kertész J. Modeling social dynamics in a collaborative environment. EPJ Data Science. 2014;3(1):1 -- 20. 59. Török J, Iñiguez G, Yasseri T, San Miguel M, Kaski K, Kertész J. Opinions, conflicts, and consensus: modeling social dynamics in a collaborative environment. Physical review letters. 2013;110(8):088701. 60. Bernardes AT, Stauffer D, Kertész J. Election results and the Sznajd model on Barabasi network. The European Physical Journal B-Condensed Matter and Complex Systems. 2002;25(1):123 -- 127. 23 REFERENCES REFERENCES 61. Caruso F, Castorina P. Opinion dynamics and decision of vote in bipolar political systems. International Journal of Modern Physics C. 2005;16(09):1473 -- 1487. 62. Fortunato S, Castellano C. Scaling and universality in proportional elections. Physical Review Letters. 2007;99(13):138701. 63. Aral S, Muchnik L, Sundararajan A. Distinguishing influence-based contagion from homophily-driven diffusion in dynamic networks. Proceedings of the National Academy of Sciences. 2009;106(51):21544 -- 21549. 64. Shalizi CR, Thomas AC. Homophily and contagion are generically confounded in observational social network studies. Sociological methods & research. 2011;40(2):211 -- 239. 65. Bishop CM, et al. Pattern recognition and machine learning. vol. 1. Springer New York; 2006. 66. Niermann S. Testing for linearity in simple regression models. AStA Advances in Statistical Analysis. 2007;91(2):129 -- 139. 67. Van der Linden D, te Nijenhuis J, Bakker AB. The general factor of personality: A meta-analysis of Big Five intercorrelations and a criterion-related validity study. Journal of research in personality. 2010;44(3):315 -- 327. 24 Supplementary Information Modelling influence and opinion evolution in online collective behaviour Corentin Vande Kerckhove, Samuel Martin, Pascal Gend, Peter J. Rentfrow, Julien M. Hendrickx, Vincent D. Blondel S1 Derivation of the measure of unpredictability S1.1 Proof that η has zero mean In section Intrinsic unpredictability estimation, we used that η has zero mean. This fact is proven in the sequel. Assume, to show a contradiction that m = E(η) 6= 0. Denote xi(2) = f i (xi(1), xothers(1), picture). 1 Then, we can show that xi(2) + m would be a better model for xi(2) than xi(2). This would contradict the definition of f i as the best model. Indeed, the expected square prediction error would be 1 E(cid:0)(xi(2) − (xi(2) + m))2(cid:1) = E(cid:0)(xi(2) − xi(2))2(cid:1) − 2mE (xi(2) − xi(2)) + m 2 = E(cid:0)(xi(2) − xi(2))2(cid:1) − m < E(cid:0)(xi(2) − xi(2))2(cid:1) , 2 where we used the fact that η = xi(2) − xi(2). The same reasoning allows to show that the prediction error ¯η at round 3 also has zero mean. S1.2 Derivation of equation (3) Equation (3) is derived using the following reasoning. The judgments made in two replicated games of a control experiment by a same participants are described as xi(2) = f 0 i(2) = f x 1 i (xi(1), xothers(1), picture) + η, 0 0 0 1 others(1), picture) + η i (x i(1), x , where the prime notation is taken for judgments from the second replicated game and η and η0 are two independent draws of the random intrinsic variation. By design, the set of judgments are all shifted by the same constant : 0 i(1) = xi(1) + s, 0 others(1) = xothers(1) + s, x x where s = x0 i(1) − xi(1) is known. According the assumption made on function f i , 1 1 i (picture) + η, 0 1 i (picture) + η i (xi(1), xothers(1)) + (1 − λ)h 1 others(1)) + (1 − λ)h 0 0 1 i (x i(1), x xi(2) = λg 0 i(2) = λg x , the second round judgment made in the second replicate is then i(2) = λ(cid:0)g 0 i (xi(1), xothers(1)) + s(cid:1) + (1 − λ)h 1 x 1 i (picture) + η 0 , where the invariance by translation of g i (xi(1), xothers(1)) and h 1 g i (picture) vanish to obtain 1 i was used. Taking the difference makes the unknown terms 1 Since η and η0 have zero mean and are assumed to have equal variance, the theoretical variance of η is i(2) − xi(2) = λs + η 0 x 0 − η. E(η (cid:0)E(η 2) = 1 2 = 1 2(E(η = 1 2(E(η = 1 2E((η 02)(cid:1) 0 2) + E(η 02) − 2E(η 02 − 2η η + η 0 − η)2) + E(η 0 η) + E(η 2) + 2E(η 0 η)) 0 η) 2)) + E(η 0 η). (6) (7) Moreover η and η0 are assumed to be independent with zero mean, i.e., , E(η) = E(η0) = 0, therefore, 2E((η0−η)2) and using equation (6), their covariance is null : E(ηη0) = E(η)E(η0) = 0. Consequently, E(η the variance of η is empirically measured as the average of 2) = 1 over all repeated games and all participants. This corresponds to equation (3). 1 2(x i(2) − xi(2) − λs)2 0 S1.3 Discussion on the assumptions on η and η0 The only assumption used to derive equation (6) is that η and η0 have the same variance and are independent for each participant. Since function f is unknown, it is not possible to directly test these assumptions. However, since pairs of replicates in the control experiment are related to the same picture, it is unlikely that the covariance between η and η0 would be negative. If the covariance was positive, the quantity given in equation (6) would become a lower bound on the unpredictability threshold, as shown through equation (7). Finally, if η and η0 did not satisfy the assumption of equal variance, the quantity in equation (6) would still correspond to the average variance 1 2 unpredictability, as seen in equation (7). 2) + E(η02)(cid:1) which also represents the average intrinsic (cid:0)E(η 1 i S2 Circumstances of the wisdom of the crowd The wisdom of the crowds may not always occur. The present section recalls one important hypothesis underlying the wisdom of the crowds. The hypothesis is then tested against the empirical data from the study. In the context of the present study, the wisdom of the crowd corresponds to the following fact: the mean opinion is most often much closer to the true answer than the individual opinions are. Denoting ¯x the mean of n opinions xi and T the corresponding true answer, this is formally expressed as ¯x − T << 1 n nX i=1 xi − T, (8) where << stands for significantly smaller than. The wisdom of the crowd given by equation 8 does not always take place. It only occurs if the opinions xi are distributed sufficiently symmetrically around the true answer. When the distribution is largely biased above or below the true answer, equation 8 fails to hold. To understand this fact, the group of individual is split in two : i ∈ N + if xi(1) > T and i ∈ N − if xi(1) < T . Then, the distance of the mean opinion to truth rewrites as (cid:12)(cid:12)(cid:12)(cid:12)(cid:12) 1 (cid:12)(cid:12)D n (cid:12)(cid:12)(cid:12)(cid:12)(cid:12) = 1 n (cid:12)(cid:12)(cid:12)(cid:12)(cid:12) nX i=1 − T nX (xi − T ) + X i∈N + xi−T ≥ 0 is the contribution from opinions above truth and D− =P i=1 + − D (xi − T ) = 1 i∈N − xi n (cid:12)(cid:12)(cid:12)(cid:12)(cid:12) = 1 n (cid:12)(cid:12)(cid:12)(cid:12)(cid:12)X i∈N + ! −(cid:12)(cid:12) ¯x − T = + =P (cid:12)(cid:12)(cid:12)(cid:12)(cid:12) (xi − T ) Pn i∈N − xi−T ≥ 0 where D is the contribution from opinions below truth. Using these notation, the average distance to truth is + + D−). As a consequence, the wisdom of the crowd described in equation 8 1 n translates to i=1 xi − T = 1 (D n (cid:12)(cid:12)D −(cid:12)(cid:12) << (D + − D + + D −). (9) Two extreme cases are possible : • Perfect wisdom of the crowd : opinions are homogeneously distributed around the true answer and D + = D− so that ¯x(1) − T = 0. • No wisdom of the crowd : opinions either totally overestimate or totally underestimate the correct nX i=1 answer and either D− = 0 or D + = 0, so that ¯x − T = 1 n xi − T. We now turn to the empirical data. Only the first round is discussed here because, in the subsequent rounds, the opinions are no longer independent, a criterion required for the wisdom of the crowd to occur. Fig. S1 displays how opinions are distributed around the true value for the gauging game (A) and the counting game (B). Both distributions fall between the two extreme cases with most opinions underestimating the true value. However, the bias is more important in the counting game which explains that the wisdom of the crowd is more prominent in the gauging game in the first round. This explains the differences between mean opinion errors and individual errors observed in Fig. 5. S3 Testing the linearity of the consensus model The consensus model (1) assumes that the opinion change xi(t + 1) − xi(t) grows linearly with the distance between xi(t) and the mean opinion ¯x(t). This assumption is tested against the alternative xi(t + 1) − xi(t) = β0 + α1(¯x(t) − xi(t))γ with γ 6= 1. The numerical statistics values are reported for the opinion change between rounds 1 and 2 for the gauging game. The same conclusions hold for the counting game and for the opinion change between rounds 2 and 3. The linearity test provided in [66] applied to our data gives a statistics P = −1.4e7 with empirical variance var(P ) = 4e14 so that we fail to reject the null hypothesis γ = 1 (p-val=0.5). Fig. S2 displays the evolution xi(t + 1) − xi(t) against the distance to the mean ¯x(t) − xi(t) along with the result of the linear regression assuming γ = 1. Influenceability and personality S4 Is influenceability related to personality ? To answer this question, we required the participants to provide information regarding their personality, gender, highest level of education, and whether they were native (A) Gauging (B) Counting Figure S1. Deviation of opinions to truth during the lone round 1. Red vertical lines split the histogram into the opinions contributing negatively to the distance between mean opinion and truth (left) and the opinions contributing positively to the distance between mean opinion and truth (right). (A) gauging game; (B) counting game. English speaker. The questionnaire regarding personality comes from a piece of work by Gosling and Rentfrow [39] and was used to estimate the five general personality traits. The questionnaire page is reported in supplementary Fig. S6. For each of the five traits, the participants rated how well they feel in adequacy with a set of synonyms (rating s ∈ {1, . . . , 7}) and with a set of antonyms (rating a ∈ {1, . . . , 7}. This redundancy allows for testing the consistency of the answer of each participants. The participants who had a distance (8 − a) − s too far away from 0 were discarded (threshold values were found using Iglewicz and Hoaglin method based on median absolute deviation [47]). Partial Pearson's linear correlations are first reported between the individual traits measured by the questionnaire (see table S1). The correlation signs are found to be consistent with the related literature on the topic [67]. This indicates that our measure of the big five factors is trustworthy. Partial correlations are then provided to link the personal traits to influenceability. As shown in Table S2, none of the measured personal traits is able to explain the variability in the influenceability parameter. The only exceptions concern gender and being English native speaker, with weak level of significance (p-val ∈ [0.01, 0.05]). However, these relations are consistent neither between types of tasks nor over rounds, so that they cannot be trusted. We conclude that the big five personality factors and the other measured individual traits are not relevant to explain the influenceability parameter. Finding appropriate individual traits to explain the influenceability remains an open question. −500500−500500 C 0.45*** E 0.38*** 0.11 A 0.31*** 0.29*** 0.03 (A) Participants from the counting game Eng -0.08 -0.06 -0.05 -0.16* 0.08 0 N -0.35*** -0.41*** -0.15* -0.48*** Gen 0.03 -0.02 0.02 0.11 0.2** (B) Participants from the gauging game C 0.37*** E 0.24*** 0.2*** A 0.29*** 0.22*** -0.12* N -0.4*** -0.29*** -0.12* -0.34*** Gen 0.06 0.15** 0.04 0.01 0.18** Eng 0.15* 0.12* 0.04 -0.07 -0.02 -0.03 Edu 0.09 0.29*** 0 0.15* -0.23*** 0.01 -0.12 Edu 0.16** 0.11 -0.03 0.08 -0.16** 0 -0.02 O C E A N Gen Eng O C E A N Gen Eng Table S1. Partial Pearson's linear correlations among the big five factors of personality (O: openness, C : calmness, E : extroversion, A : agreeableness, N : neuroticism), gender (Gen), native English speaker (Eng) and highest level of education (Edu). Significance : *p-val< 0.05, **p-val< 0.01,***p-val< 0.001. (A) Gauging α(1) -0.1 0.08 -0.1 0 -0.06 -0.14* -0.09 0.05 α(2) -0.04 -0.06 0.02 -0.02 0.03 -0.05 0.02 -0.1 O C E A N Gen Eng Edu (B) Counting α(1) 0.07 -0.05 -0.01 0.1 -0.1 0.03 -0.03 -0.04 α(2) -0.05 -0.09 -0.01 0.07 0.01 0.12* -0.12* -0.1 Table S2. Partial Pearson's linear correlations linking influenceability to the big five factors of personality (O: openness, C : calmness, E : extroversion, A : agreableness, N : neuroticism), gendre (Gen), native English speaker (Eng) and highest level of education (Edu). Significance : *p-val< 0.05, **p-val< 0.01,***p-val< 0.001. (A) Gauging (B) Counting Opinion change 2 o t 1 d n u o r m o r f 3 o t 2 d n u o r m o r f Difference between mean and own opinion Figure S2. Opinion change xi(t + 1) − xi(t) versus difference between mean and individual opinion ¯x(t) − xi(t). The color in each cell corresponds to the number of data points falling in the cell. The color scale is logarithmic. The black strait line represents the linear regression xi(t+1)− xi(t) = β0 + α(t)(¯x(t)− xi(t)). Top : opinion change from round 1 to 2 ; bottom : opinion change from round 2 to 3. (A) gauging game; (B) counting game. −40−2002040−40−2002040 0425132678−40−2002040−40−2002040 0424124625−40−2002040−40−2002040 05321931119−40−2002040−40−2002040 0429163894 S5 Additional figures for prediction accuracy S5.1 Confidence intervals for prediction errors Fig. S3 displays error bars for 95% confidence interval of the RMSEs. This figure reveals that the two methods depending on training set size do not perform significantly better than the consensus model with one couple of typical influenceabilities, even for large training set sizes. This is an argument to favor the model in which the whole population has a unique couple of influenceabilities (α(1), α(2)). (A) Gauging - RMSE, detailed error bars (B) Counting - RMSE, detailed error bars Figure S3. Root mean square error (RMSE) of the predictions with detailed error bars for the final round. S5.2 Prediction accuracy in terms of Mean Absolute Errors Measuring prediction accuracy in terms of MAEs may appear more intuitive for comparing prediction methods. Fig. S4. assesses the models using an absolute linear scale, where the errors are deliberately unscaled for the counting game. The prediction methods rank equally when measured in terms of MAE or RMSE. Notice that, due to nonlinear relation between RMSE and MAE, on this alternative scale, the consensus models errors are now closer from the null model than from the unpredictability error. For comparison, recall that for the gauging game, the judgments range between 0 and 100 while they range between 0 and 500 for the counting game. (C) Gauging - MAE (D) Counting - MAE Figure S4. Mean absolute error (MAE) of the predictions (unscaled) for the final round. Individual past informationNullConsUnp151015RMSE5.3589101112Individual 2 typical Individual past informationNullConsUnp151015RMSE8.239101112Individual 2 typical Individual past informationNullConsUnp151015MAE2.3934567Individual 2 typical Individual past informationNullConsUnp151015MAE18.925303540Individual 2 typical Figure S5. Login page. Figure S6. Questionnaire form. Figure S7. Instruction page. (A) (B) Figure S8. (A) Interface of the first round for the counting game, played alone. (B) Instances of pictures for the gauging game. Figure S9. Interface of the second and third rounds for the counting game, social rounds Figure S10. Debrief page.
1804.09304
1
1804
2018-04-25T00:56:41
Real-Time Inference of User Types to Assist with More Inclusive Social Media Activism Campaigns
[ "cs.SI", "cs.AI" ]
Social media provides a mechanism for people to engage with social causes across a range of issues. It also provides a strategic tool to those looking to advance a cause to exchange, promote or publicize their ideas. In such instances, AI can be either an asset if used appropriately or a barrier. One of the key issues for a workforce diversity campaign is to understand in real-time who is participating - specifically, whether the participants are individuals or organizations, and in case of individuals, whether they are male or female. In this paper, we present a study to demonstrate a case for AI for social good that develops a model to infer in real-time the different user types participating in a cause-driven hashtag campaign on Twitter, ILookLikeAnEngineer (ILLAE). A generic framework is devised to classify a Twitter user into three classes: organization, male and female in a real-time manner. The framework is tested against two datasets (ILLAE and a general dataset) and outperforms the baseline binary classifiers for categorizing organization/individual and male/female. The proposed model can be applied to future social cause-driven campaigns to get real-time insights on the macro-level social behavior of participants.
cs.SI
cs
Real-Time Inference of User Types to Assist with more Inclusive and Diverse Social Media Activism Campaigns Habib Karbasian, Hemant Purohit, Rajat Handa, Aqdas Malik and Aditya Johri Department of Information Sciences and Technology, George Mason University, Virginia, USA {hkarbasi, hpurohit, rhanda, amalik21, johri}@gmu.edu 8 1 0 2 r p A 5 2 ] I S . s c [ 1 v 4 0 3 9 0 . 4 0 8 1 : v i X r a Abstract Social media provides a mechanism for people to engage with social causes across a range of issues. It also provides a strategic tool to those looking to advance a cause to ex- change, promote or publicize their ideas. In such instances, AI can be either an asset if used appropriately or a barrier. One of the key issues for a workforce diversity campaign is to understand in real-time who is participating - specifically, whether the participants are individuals or organizations, and in case of individuals, whether they are male or female. In this paper, we present a study to demonstrate a case for AI for social good that develops a model to infer in real-time the different user types participating in a cause-driven hash- tag campaign on Twitter, ILookLikeAnEngineer (ILLAE). A generic framework is devised to classify a Twitter user into three classes: organization, male and female in a real-time manner. The framework is tested against two datasets (IL- LAE and a general dataset) and outperforms the baseline bi- nary classifiers for categorizing organization/individual and male/female. The proposed model can be applied to future social cause-driven campaigns to get real-time insights on the macro-level social behavior of participants. Introduction Social media activism has emerged as a key mechanism for people to engage with social causes that interest them and in many instances such as BlackLivesMatter, social me- dia has been a significant contributor to the overall cause (De Choudhury et al. 2016). Similarly, in recent years social media activism campaigns such as #ILookLikeAnEngineer, #FearlessGirl, and #Uber have raised the issues of lack of di- versity in the workforce, especially the lack of gender diver- sity in the technology workforce. These campaigns can be seen as ways for AI-driven societal engagement since these platforms run on digital data and are applicable to AI algo- rithms and provide people tools for engaging with society in the digital world. Technology and specifically AI can of course either assist large social causes or hinder progress. In this paper, we are studying a specific way in which AI and related techniques can help those engaged in social me- dia activism to better target their messaging and improve their engagement with participants. It is commonly reported Copyright c(cid:13) 2018, Association for the Advancement of Artificial Intelligence (www.aaai.org). All rights reserved. that one of the primary deficiencies of social media cam- paigns is that they only engage those who are already in- terested in the topic of the campaign, often creating "fil- ter bubbles." The other criticism targeted towards activism campaigns on social media is that they reflect a form of laziness by participants ("slacktivism") and online participa- tion does not translate into offline action. Many researchers and practitioners argue against this characterization of so- cial media campaigns by arguing that there are residual ef- fects of participating in these efforts and people who par- ticipate in social media activism campaigns are more likely to participate in other similar causes (Lee and Hsieh 2013; Skoric 2012). There are other considerations of such cam- paigns as well, such as whether they are being co-opted by other actors - media, corporations - and to what extent. Diani (Diani 1992) proposed three criteria that character- ize a social movement: (1) there is a network of informal interactions among a diverse group of individuals, groups and/or organizations; (2) this network is engaged in some form of a political or cultural conflict; and (3) there is an accepted sense of shared collective identity among the net- work. In that regard, diverse group of users/organizations plays an inescapable role in bringing people together for social good. Although every online activism does not get molded into a movement, social technologies have unique affordances to support diverse participation in social move- ments and allow users to engage with a social movement in ways that are different than participation in earlier so- cial movements. In particular, users can now connect loosely through signaling their support via a tweet, for instance al- lowing for different forms of organizing or connective ac- tion. Hence, classifying user type is important for identify- ing key actors in sustaining social movement such as IL- LAE. In a recent article, (Vaast et al. 2017) combine these two perspectives to argue that, "Affordances of social me- dia for connective action may thus be actualized by emerg- ing and fluid groups of actors who are involved in differ- ent ways and to different degrees in connective action (p.5)" The authors further suggest that different users might take on different roles within the activity, "complementary, inter- dependent roles that make up the connective action." These relationships, according to them, have not been investigated empirically and there is a need to better understand the affor- dances of social media that enable connective action (Vaast et al. 2017). Therefore, gaining insight into user demograph- ics such as gender, age, ethnicity, etc. (Bergsma et al. 2013; Volkova et al. 2015) is essential for promoting wider so- cial engagement. One of the most critical attributes among them is gender (user type) given the prevalent gender stereo- typing in the society. Thus, the key objective of this pa- per is to develop a method to automatically identify user types in real-time for supporting analysis of campaign dy- namics, whether they are individuals or organizations (Mc- Corriston, Jurgens, and Ruths 2015; De Choudhury, Di- akopoulos, and Naaman 2012; De Silva and Riloff 2014) as well as female/male (Burger et al. 2011; Chen et al. 2015; Bergsma et al. 2013). One of the main drawbacks in prior works on user type categorization is that they are computationally expensive due to the high dimensionality of feature representation ex- tracted from textual data (Bergsma et al. 2013; Burger et al. 2011). The sparsity of available information with a user profile in real-time has led to dependence on historical infor- mation such as the text of Twitter messages (tweets) from a user profile (McCorriston, Jurgens, and Ruths 2015) for fea- ture extraction, keywords in tweets (Volkova and Yarowsky 2014), and user mentions in tweets (Bergsma et al. 2013) and friends/followers information (Chen et al. 2015). Fur- thermore, all of the prior works have modeled the user type categorization problem as a binary classification (organiza- tion/individual or female/male) task and they have not ex- plored any differences in the characteristics of user types that may be specific to the participation in a campaign com- munity, in contrast to general user sample on a social net- work. In (Johri et al. 2018), the four main influential drivers of an online social campaign are detected and discussed but the focus of this paper is to analyze the user type categorization problem in the context of a social media campaign as well as with general dataset, so as to identify any specific patterns of user type characteristics. Contributions. Our main contribution in this paper is a method for assisting real-time characterization of users in- volved in a social media campaign, specifically the ILLAE campaign on Twitter. Our findings suggest that female users are both more numerous and active than males. Unlike other social movements, this campaign attracted a much higher number of organizational participants and they are more en- gaged and tweet at a higher level. When combined with other information that is easily available, this characterization can provide information on which organizations and what mes- saging etc. Improvements to Prior Work. Characterizing users has been attempted in many studies. Our aims in this work are to improve on prior work in two aspects: 1) characterize not just individuals into male/female but also into individuals and organizations; and, 2) to create a process and framework that allows real-time analysis as opposed to using informa- tion and features that can only be assessed or computed ret- rospectively. Overall, we propose a user type classification framework with the following contributions: • It is a unified approach to address user type classification problem by combining all user types together, individuals (male/female) and organizations into one framework. • Our framework addresses Twitter API limitations by us- ing features available in real-time in the user's one tweet and user profile for the classification task as opposed to other methods which require additional information about the user or user's social network, such as friends, follow- ers, and user mentions. • The proposed framework encompasses features from mul- tiple characteristics of information such as user profile's description, name, tweet and profile images making it comprehensive. • Although automatic user type classification suffers from several caveats such as low recall (Minkus, Liu, and Ross 2015) and classification error (Yadav et al. 2014), it is very computationally and financially efficient to study online social media activism in a real-time manner. The remainder of the paper is organized as follows. In the datasets section, we describe the two datasets used in this pa- per. In framework section, we explain each component of the framework and its structure. Experiment section talks about experimental settings, baselines and performance analysis for each dataset. Finally, we conclude the paper with limi- tation and future works. Datasets In this work, we use two datasets of users from Twitter so- cial network; one domain-specific (online social campaign – ILookLikeAnEngineer) and one general dataset (Crowd- Flower1). Each dataset consists of the tweet metadata (such as creation time, tweet id, tweet text, location, user mentions and etc.) and user metadata (such as user's screen name, pro- file image, friends/followers/tweet count and etc.). ILookLikeAnEngineer (ILLAE) The domain-specific dataset is based on ILookLikeAnEngi- neer campaign. The #ILookLikeAnEngineer Twitter hashtag was an outgrowth of an advertising campaign by the com- pany OneLogin. In late July 2015, the company OneLogin posted billboards across public transport in the California Bay Area. One of the employees in the advertisement was a female engineer, Isis Anchalee, who brought so much atten- tion to the online community. Her image led to discussions online about the veracity of the campaign as some people found it unlikely that she was really an engineer. Then she came up with the #ILookLikeAnEngineer Twitter hashtag and it created a momentum for other female peers in engi- neering to contribute to this campaign. (Figure 1) We collected the dataset from Twitter using streaming API and based on three hashtags #ILookLikeAnEngineer, #LookLikeAnEngineer and #LookLikeEngineer as we had found instances of all of them being used in conjunction. The time frame for the data ranges from August 3rd, 2015, the day the hashtag was first used, until October 15th, 2015, which is about 2 months after the first initial surge of the 1https://www.kaggle.com/crowdflower/ twitter-user-gender-classification dataset, there are 13926 users. Because most of the user's image URL didn't work, we had to recollect the users' data from Twitter API based on their Twitter handle. At the end, we were able to retrieve 10186 users. The distribution of the CrowdFlower dataset is presented in Table 1. Dataset Male Female Organization ILLAE CrowdFlower 451 630 353 24.62% 31.45% 43.93% 3,698 2,464 36.30% 39.51% 24.19% 4,024 Total 1,434 100% 10,186 100% Table 1: Datasets with user distributions Framework Here, we propose a framework that uses multiple types of in- formation from a user's one tweet and user profile informa- tion to classify the users into male, female or organization. This framework uses multi-modality of information from a user: screen name, image, metadata, and a tweet text. In this section, we explain every component of the framework. Then we explain the proposed framework. Tweet Name Text Image Metadata Male Classifier Female Organization Figure 2: Proposed framework for user type classification with the help of multi-modality of information Name In (Liu and Ruths 2013), it is inferred that including name as a feature in existing classifiers yields a 20% increase in accuracy. Therefore, name is a great discriminant feature for user type classification. We use a name database3 that tries to infer a person's gender from their name. This database is cre- ated by the data that came from national statistics institutes and was accompanied by frequency information. A Twitter user has a screen name and Twitter handle. Although some Twitter handles has some information about the user, with preliminary experiments, the performance on screen name is much higher than that of Twitter handle making screen name the input for the database that classifies users into fe- male, male, unisex and none. So it is highly effective for individuals' name but for organizations, we need additional information that will be discussed in the following sections. Figure 1: Start of Twitter Campaign campaign. The dataset consists of 19,492 original tweets from 13,270 unique users (individuals and organizations). Three reviewers from our research team individually anno- tated 1,434 user profiles as female, male or organization. The annotated user profiles were reviewed by the team and in case of a disagreement, the user type was decided by mutual discussion. The distribution of each user type for ILLAE is shown in Table 1. By applying social network analysis to this dataset, de- gree centrality (the in-degree and out-degree) was calculated for each user in the interaction network (created by equally weighted directed edges for attribution in each interaction type of retweet, mention or reply from user-A to user-B). The analysis revealed that 76 percent of top 25 users, manu- ally annotated, with highest in-degree, were organizations. PageRank and betweenness centralities further confirmed that organizations played an important role in the trending of the movement and in connecting and bringing users together for movement. Overall, we observed a markedly strong role for organizations in the campaign, which is likely due to their reputations and workforce diversity-related initiatives. Broadly, the top contributors can be divided into individ- uals (Male/Female) and organizations such as Tesla, Intel, GE, BBC, Independent, BuzzFeed, Fortune, TechCrunch. Among the individuals, the most active one is a female engi- neer (Michelle Glauser), who was the manager for the hash- tag campaign and who worked with Anchalee to start the campaign. CrowdFlower This dataset was used to train a CrowdFlower AI gender pre- dictor 2. Contributors were asked to visit a Twitter profile link and judge whether the user was a male, a female, or a brand (non-individual). The dataset contains 20,000 rows, each with a username, a random tweet, account profile and image, location, and even link and sidebar color. Because of multiple annotation results by different people, each row has a certain degree of confidence signifying the likelihood of the majority gender. In order to make sure that we work on the cleanest data possible, we filtered every user type that had a degree of confidence less than 1. After filtering the 2https://www.crowdflower.com/ 3https://github.com/tue-mdse/ using-machine-learning-to-predict-gender/ genderComputer Text The textual information about the tweet is the tweet text and the profile description of the user. In prior works, character- based features generated by n-gram method were used to encode the text. But the main drawback of this method is the lack of generalization to capture unseen input fea- tures because the model was unable to learn those features that were not created in the training phase. (Bergsma et al. 2013)). To overcome this, we use an approach to analyze the language used in these texts by word-category lexicon; the most widely used is Linguistic Inquiry and Word Count (LIWC), developed over the last couple decades by hu- man judges designating categories for common words (Pen- nebaker et al. 2015; Pennebaker, Mehl, and Niederhoffer 2003; Schwartz et al. 2013). By LIWC, the psychological value of language in gender can be quantified with 94 dif- ferent categories of language ranging from part-of-speech (i.e. articles, prepositions, past-tense verbs, numbers,...) to topical categories (i.e. family, cognitive mechanisms, affect, occupation, body,...), as well as a few other attributes such as total number of words used (Pennebaker et al. 2015; Chung and Pennebaker 2007). Image Profile images are very popular on social network and Twit- ter is not an exception. This gives an opportunity to leverage the visual information provided by users. There are many algorithms such as SIFT (Lowe 2004), SURF (Bay, Tuyte- laars, and Van Gool 2006) etc. for image recognition task but due to handcrafted rules for feature extraction process we decided to use one of the automatic feature extraction algorithms such as state-of-the-art Convolution Neural Net- works (ConvNets). Among many ConvNets models, we se- lected VGG-16 model – a 16-layered convolutional archi- tecture – due to fast computational capability. The model re- turns 1,000 probabilities for each image, that the model as- signs to each possible ImageNet4 category. During the train- ing phase, we trained the model for 20 epochs on the training dataset. We follow 70% (training), 20% (development) and 10% (testing) split for our dataset. We achieved an accuracy of 75% on the validation set on the domain-specific dataset (ILLAE) and 74.28% on CrowdFlower dataset. Metadata In (Khabiri, Hsu, and Caverlee 2009), it is studied how a Social Web community itself perceives the quality of so- cially generated metadata within the community. To make the model more comprehensive, we use the metadata of each user including followers count, friends count, tweets (sta- tuses) count and verified status. Proposed Model Features Based on the feature groups explained above, we create 4 categories of features • Name: Given user name, it predicts gender categories; fe- male, male and unisex (3 categorical) 4http://www.image-net.org • Text: Given a tweet text and profile description, it gives you features of LIWC , except for word count, others are the percentage of each category (2 ∗ 94 = 188 numerical) • Image: Given user profile image, it returns 1000 proba- bilities to which category it belongs (1000 numerical) • Metadata: friends, followers and tweet counts with veri- fied status (3 numerical and 1 categorical) The expected output is the three classes: female, male, or organization. We use 4 different classification algorithms: naıve Bayes, multinomial logistic regression, support vector machine (SVM) and random forest (RF). In our preliminary results with the sample datasets, naıve Bayes and multinomial lo- gistic regression were always outperformed by SVM and RF. So we continued with SVM and RF for the rest of the exper- iments that will be discussed in the next section. Experiments Prior works address binary classification problem of identi- fying user type (female/male or individual/organization) but our model tries to classify user types into three classes (fe- male/male/organization). To show the performance of each classifier, we use overall accuracy and F1score for each class. Experimental Settings To keep different classifiers consistent, we use the default value for the parameters of the classifiers. We train the model with each set of features separately and finally all combined as our proposed framework. Then we test them and report the performance measures by the averaging of the 10 fold cross validation across the annotated dataset. (Table 1) We use both log-count and normalization of each feature vector as preliminary experiments show the improvement compared to the original data. Some of the user profiles have no image or non-working im- age URL. Therefore we use single imputation to replace the non-existing feature value for the respective user by using the average of that particular feature. Baselines We use three baselines. Like prior works, we use the major- ity class as our baseline which classifies all users as the max- imum likelihood class. In addition to that, we use the name database which is also one of the feature sets as another baseline. It takes username as input and outputs binary labels for female/male. For individual/organization baseline, we use the trained model in (McCorriston, Jurgens, and Ruths 2015)5. It has 110 features derived from last 200 tweets and user metadata that are trained by SVM then it classifies users into individual/organization. Even though it uses historical tweets from the users and it cannot be applied to real-time classification task, our proposed framework outperforms this as you can see in the following section. 5https://github.com/networkdynamics/ humanizr Baselines Framework Baselines Framework Methods Accuracy(%) F1-Org(%) F1-Female(%) F1-Male(%) Majority (org) Organization/Individual Text Image Name database SVM RF SVM RF SVM RF SVM RF Proposed Metadata 43.93 37.31 45.08 67.50 66.39 70.00 72.24 57.67 52.65 83.34 85.99 61.01 84.85 0 82.41 81.26 87.77 91.65 70.02 67.24 89.55 92.21 0 0 71.41 63.37 61.78 57.90 63.53 50.62 39.89 79.00 83.13 0 0 73.20 37.14 34.11 49.02 44.54 38.85 39.87 75.32 77.25 Table 2: Classifiers results in different feature sets for ILLAE dataset Methods Accuracy(%) F1-Org(%) F1-Female(%) F1-Male(%) Majority (female) Organization/Individual Text Image Name database SVM RF SVM RF SVM RF SVM RF Proposed Metadata 39.51 14.50 46.67 62.02 61.43 63.42 64.55 48.70 47.17 78.61 76.56 68.74 0 0 70.90 70.53 72.94 75.71 52.07 51.95 81.27 78.86 56.63 0 68.66 65.02 64.45 62.78 64.83 56.47 50.68 79.83 78.72 0 0 70.11 52.10 51.66 57.30 56.63 34.36 39.85 75.40 72.64 Table 3: Classifiers results in different feature sets for CrowdFlower dataset Discussion In this section, we analyze the results of the experiments, the implications of the developed model for analyzing social media campaigns as well as the limitation and future work for real-time user analytics research. In Table 2, the performance of each baseline is calculated based on overall accuracy and F1 score for each class. As you can see, organization/individual classifier does the best job among baselines with 84.85% F1 score for organization class as it serves its main purpose. But the classifier with image feature set outperforms that classifier with 87.77% and 91.65% F1 score in both classifiers. It means image is a more discriminant feature than historical tweets. On the other hand, name database is effective in gender classifica- tion of individuals and it outperforms all of the other clas- sifiers except the proposed framework. At the end, the pro- posed classifier with RF outperforms all of the other classi- fiers with the average overall accuracy of 85.99%. In Table 3, you will see the result of CrowdFlower dataset. But in this dataset, organization/individual classifier with 68.74% F1 score for organization class is outperformed by two classifiers beside the combined one: text (70.90% and 70.53% F1 score-org) and image (72.94% and 75.71% F1 score-org). Image and text features alone are enough to clas- sify organizations and there is no need to gather extra in- formation about the historical tweets or behavioral features in the user profile. Again, the name database has higher F1 score-female (70.11%) than the other classifiers except the combined one. Proposed framework with SVM classifier outperforms the rest of classifiers with the average overall accuracy of 78.61%. Another interesting observation here between these two datasets is F1 score of male class is always less than that of female class except for that of their name database. It shows that men do not usually follow a common ground in the Twitter as opposed to women in terms of profile image and the content of their tweets which are not as reflective of their gender as that of women. To find out the user type distribution in the entire ILLAE dataset, the model is trained with the annotated profile users (1434) and then is applied to the rest of the users (11,863) to see the user type distribution in the entire dataset. For those users with missing value in their features (e.g.: image), sin- gle imputation is used to replace the non-existing feature value by using the average of that particular feature from annotated user profiles. The user distribution of the ILLAE dataset, Table 4, shows that female users are the most dom- inant user types in this online social campaign with 47.95% which is followed by organizations with 35.31%. Organiza- tion's presence in this dataset exceeding 35% is completely much more than that of a random dataset which is less than 10% (McCorriston, Jurgens, and Ruths 2015). This confirms the fact that in an online social campaign like ILLAE, orga- nizations try to establish their presence to not only promote the cause but also create a new venue to spread their message and gain more marketing share. At last, male users did not engage in this social campaign as much as other user types. Male Female Organization Total User 2,222 6,362 16.74% 47.95% 4,686 35.31% 13,270 100% Table 4: User type distribution in entire ILLAE dataset On the same note, we would like to see the tweet, retweet and favorite distribution for each user types in the entire IL- LAE dataset. In Table 5, female is the most dominant user type in all of the categories as it shows the importance of this campaign among women. Organizations' impact on this campaign is noteworthy in a sense that one of the main fac- tors of sustainability in an online social campaign is the high level of organization engagement to involve more people in the cause. This is also confirmed by the social network anal- ysis in the previous section that in the top 25 users with high- est in-degree, 76% of them are of organization type. Male Female Organization Total Tweet Retweet Favorite 8,993 2,995 15.36% 46.14% 8,464 47,764 9.44% 53.28% 15,830 82,009 11.08% 57.41% 7,504 38.50% 33,422 37.28% 45,019 31.51% 19,492 100% 89,650 100% 142,858 100% Table 5: Tweet, retweet and favorite distribution in entire ILLAE dataset Although these results are not completely accurate, it gives a good sense of user type distribution in an online campaign in a much faster, more economical and efficient manner. Therefore, it is a great tool for real-time monitoring of participation level during the campaign course of action. In this paper, we propose a classification framework using multiple data elements in one tweet and without extra information like user's social network structure (friends/followers), historical tweets, and other additional (user mentions) information, it can outperform the existing classifiers. Also, this framework can be utilized in real-time application processes such as user type classification in disaster response context where time and resources are very crucial and limited, specially due to Twitter API limitation which makes it impossible to be extended to many incoming user's tweets which inevitably leads to service halt. Limitations and Future Work Our work has some limitations, particularly in image recog- nition section. While investigating the performance of the VGG-16 model, it came to our attention that the convolu- tional network could not learn features differentiating user type because of two important reasons. The first one was that few profile pictures of individual users were of organi- zation type, hence the network failed to learn the discrim- inatory features. The second reason was that female profile pictures with short hair were classified as male. The network was unable to learn masculine features such as beard which differentiate male from female during the training. For future, there are other user information like location, background profile image, the color of the user profiles, hashtags, URLs and media in a tweet (photos and videos) that could be integrated into this framework to improve the performance. One more interesting thing that also deserves the attention is to see why men are hard to be classified in Twitter in terms of the content and if there is another dis- criminant feature except for their name which can bring F1 score of men closer to that of women. Conclusion This study makes an important contribution to our under- standing and practice of how AI and associated techniques can help those engaged in social media movements and ac- tivism campaigns. Our proposed framework make use of features from the diverse mode of information such as user profile description, name, tweet and profile images making it comprehensive. Hence, the multi-modality of information provides the framework for the real-time analysis of user types and a more nuanced assessment of users participat- ing in an online activism campaign. For leveraging social media for social good, using our framework, campaign di- rectors can ensure that their message is going through to the right audience. This work is also applicable to other do- mains where identifying organizations, for instance emer- gency management, is important and where identifying fe- male/male participants is crucial (any campaign directed to- wards diversity of issues such as gender-based violence). Acknowledgment This research was partially supported by U.S. National Sci- ence Foundation Award 1707837. References Bay, H.; Tuytelaars, T.; and Van Gool, L. 2006. Surf: Speeded up robust features. Computer vision–ECCV 2006 404–417. Bergsma, S.; Dredze, M.; Van Durme, B.; Wilson, T.; and Yarowsky, D. 2013. Broadly improving user classification via communication-based name and location clustering on twitter. In HLT-NAACL, 1010–1019. Pennebaker, J. W.; Mehl, M. R.; and Niederhoffer, K. G. 2003. Psychological aspects of natural language use: Our words, our selves. Annual review of psychology 54(1):547– 577. Schwartz, H. A.; Eichstaedt, J. C.; Kern, M. L.; Dziurzyn- ski, L.; Ramones, S. M.; Agrawal, M.; Shah, A.; Kosinski, M.; Stillwell, D.; Seligman, M. E.; et al. 2013. Personality, gender, and age in the language of social media: The open- vocabulary approach. PloS one 8(9):e73791. Skoric, M. M. 2012. What is slack about slacktivism. Methodological and conceptual issues in cyber activism re- search 77:77–92. Vaast, E.; Safadi, H.; Lapointe, L.; and Negoita, B. 2017. Social media affordances for connective action-an examina- tion of microblogging use during the gulf of mexico oil spill. MIS Quarterly. Volkova, S., and Yarowsky, D. 2014. Improving gender prediction of social media users via weighted annotator ra- tionales. In NIPS 2014 Workshop on Personalization. Volkova, S.; Bachrach, Y.; Armstrong, M.; and Sharma, V. 2015. Inferring latent user properties from texts published in social media. In AAAI, 4296–4297. Yadav, D.; Singh, R.; Vatsa, M.; and Noore, A. 2014. Rec- ognizing age-separated face images: Humans and machines. PloS one 9(12):e112234. Burger, J. D.; Henderson, J.; Kim, G.; and Zarrella, G. 2011. Discriminating gender on twitter. In Proceedings of the Con- ference on Empirical Methods in Natural Language Pro- cessing, 1301–1309. Association for Computational Lin- guistics. Chen, X.; Wang, Y.; Agichtein, E.; and Wang, F. 2015. A comparative study of demographic attribute inference in twitter. ICWSM 15:590–593. Chung, C., and Pennebaker, J. W. 2007. The psychological functions of function words. Social communication 343– 359. De Choudhury, M.; Jhaver, S.; Sugar, B.; and Weber, I. 2016. Social media participation in an activist movement for racial equality. In ICWSM, 92–101. De Choudhury, M.; Diakopoulos, N.; and Naaman, M. 2012. Unfolding the event landscape on twitter: classification and exploration of user categories. In Proceedings of the ACM 2012 conference on Computer Supported Cooperative Work, 241–244. ACM. De Silva, L., and Riloff, E. 2014. User type classification of tweets with implications for event recognition. ACL 2014 98. Diani, M. 1992. The concept of social movement. The sociological review 40(1):1–25. Johri, A.; Karbasian, H.; Malik, A.; Handa, R.; and Purohit, H. 2018. How diverse users and activities trigger connective action via social media: Lessons from the twitter hashtag campaign# ilooklikeanengineer. In Proceedings of the 51st Hawaii International Conference on System Sciences. Khabiri, E.; Hsu, C.-F.; and Caverlee, J. 2009. Analyzing and predicting community preference of socially generated metadata: A case study on comments in the digg community. In ICWSM. Lee, Y.-H., and Hsieh, G. 2013. Does slacktivism hurt ac- tivism?: the effects of moral balancing and consistency in online activism. In Proceedings of the SIGCHI Conference on Human Factors in Computing Systems, 811–820. ACM. Liu, W., and Ruths, D. 2013. What's in a name? using first names as features for gender inference in twitter. In AAAI spring symposium: Analyzing microtext, volume 13, 01. Lowe, D. G. 2004. Distinctive image features from scale- International journal of computer vi- invariant keypoints. sion 60(2):91–110. McCorriston, J.; Jurgens, D.; and Ruths, D. 2015. Organi- zations are users too: Characterizing and detecting the pres- ence of organizations on twitter. In Proceedings of the 9th International AAAI Conference on Weblogs and Social Me- dia (ICWSM), 650–653. Minkus, T.; Liu, K.; and Ross, K. W. 2015. Children seen but not heard: When parents compromise children's online privacy. In Proceedings of the 24th International Conference on World Wide Web, 776–786. International World Wide Web Conferences Steering Committee. Pennebaker, J. W.; Boyd, R. L.; Jordan, K.; and Blackburn, K. 2015. The development and psychometric properties of liwc2015. Technical report.
1905.00825
2
1905
2019-05-04T00:42:13
Characterizing Attention Cascades in WhatsApp Groups
[ "cs.SI", "cs.CY" ]
An important political and social phenomena discussed in several countries, like India and Brazil, is the use of WhatsApp to spread false or misleading content. However, little is known about the information dissemination process in WhatsApp groups. Attention affects the dissemination of information in WhatsApp groups, determining what topics or subjects are more attractive to participants of a group. In this paper, we characterize and analyze how attention propagates among the participants of a WhatsApp group. An attention cascade begins when a user asserts a topic in a message to the group, which could include written text, photos, or links to articles online. Others then propagate the information by responding to it. We analyzed attention cascades in more than 1.7 million messages posted in 120 groups over one year. Our analysis focused on the structural and temporal evolution of attention cascades as well as on the behavior of users that participate in them. We found specific characteristics in cascades associated with groups that discuss political subjects and false information. For instance, we observe that cascades with false information tend to be deeper, reach more users, and last longer in political groups than in non-political groups.
cs.SI
cs
(UFMG), Brazil Jussara Almeida [email protected] Dept. of Computer Science, Universidade Federal de Minas Gerais (UFMG), Brazil (UFMG), Brazil Humberto T. Marques-Neto [email protected] Dept. of Computer Science, Pontifícia Universidade Católica de Minas Gerais (PUC Minas), Brazil (UFMG), Brazil Virgílio Almeida∗ [email protected] Dept. of Computer Science, Universidade Federal de Minas Gerais (UFMG), Brazil Characterizing Attention Cascades in WhatsApp Groups Marcos Gonçalves Josemar Alves Caetano [email protected] [email protected] Dept. of Computer Science, Gabriel Magno [email protected] Dept. of Computer Science, Dept. of Computer Science, Universidade Federal de Minas Gerais Universidade Federal de Minas Gerais Universidade Federal de Minas Gerais 9 1 0 2 y a M 4 ] I S . s c [ 2 v 5 2 8 0 0 . 5 0 9 1 : v i X r a ABSTRACT An important political and social phenomena discussed in several countries, like India and Brazil, is the use of WhatsApp to spread false or misleading content. However, little is known about the information dissemination process in WhatsApp groups. Attention affects the dissemination of information in WhatsApp groups, deter- mining what topics or subjects are more attractive to participants of a group. In this paper, we characterize and analyze how attention propagates among the participants of a WhatsApp group. An atten- tion cascade begins when a user asserts a topic in a message to the group, which could include written text, photos, or links to articles online. Others then propagate the information by responding to it. We analyzed attention cascades in more than 1.7 million messages posted in 120 groups over one year. Our analysis focused on the structural and temporal evolution of attention cascades as well as on the behavior of users that participate in them. We found specific characteristics in cascades associated with groups that discuss po- litical subjects and false information. For instance, we observe that cascades with false information tend to be deeper, reach more users, and last longer in political groups than in non-political groups. CCS CONCEPTS • Networks → Online social networks; • Information sys- tems → Chat. KEYWORDS WhatsApp; Cascades; Information Diffusion; Misinformation; So- cial Computing ∗Also with Berkman Klein Center for Internet & Society, Harvard University, USA. Permission to make digital or hard copies of all or part of this work for personal or classroom use is granted without fee provided that copies are not made or distributed for profit or commercial advantage and that copies bear this notice and the full citation on the first page. Copyrights for components of this work owned by others than ACM must be honored. Abstracting with credit is permitted. To copy otherwise, or republish, to post on servers or to redistribute to lists, requires prior specific permission and/or a fee. Request permissions from [email protected]. WebSci '19, June 30-July 3, 2019, Boston, MA, USA © 2019 Association for Computing Machinery. ACM ISBN 978-x-xxxx-xxxx-x/YY/MM...$15.00 https://doi.org/10.1145/nnnnnnn.nnnnnnn ACM Reference Format: Josemar Alves Caetano, Gabriel Magno, Marcos Gonçalves, Jussara Almeida, Humberto T. Marques-Neto, and Virgílio Almeida. 2019. Characterizing Attention Cascades in WhatsApp Groups. In 11th ACM Conference on Web Science (WebSci '19), June 30-July 3, 2019, Boston, MA, USA. ACM, New York, NY, USA, 10 pages. https://doi.org/10.1145/nnnnnnn.nnnnnnn 1 INTRODUCTION Global mobile messenger apps, such as WhatsApp, WeChat, Signal, Telegram, and Facebook-Messenger, are popular all over the world. WhatsApp, in particular, with more than 1.5 billion users [11], has an expressive penetration in many countries like South Africa, In- dia, Brazil, and Great Britain. Messenger apps are an important medium by which individuals communicate, share news and in- formation, access services and do business and politics. With end- to-end encryption added to every conversation, WhatsApp sets the bar for the privacy of digital communications worldwide. As a consequence, in many countries, WhatsApp has been used by political parties and religious activists to send messages and dis- tribute news. The combination of encrypted messages and group messaging has proved to be a valuable tool for mobilizing political support and disseminating political ideas [21]. There is growing ev- idence of unprecedented disinformation and fake news campaigns in WhatsApp. In India, false rumors and fake news intended to inflame sectarian tensions have gone viral on WhatsApp, leading to lynching mobs and death of dozens of people [16]. Misleading messages with fake news and photos containing disinformation have been used to influence real-world behavior in the Brazilian elections in 2018 [3]. A key component of the WhatsApp architecture is group chats, which allow group messaging. Groups are unstructured spaces where participants can share messages, photos, and videos with up to 256 people at once. Much of the political action in WhatsApp takes place in private groups and through direct messaging, which are impossible to analyze due to the encryption protocol. However, there is a large number of groups that are often publicized in well- known websites. These groups are open to new participants. After joining a group, a participant can post messages and receive the messages that circulate in the group. Unstructured conversations are the most usual form of conversation in a group chat. Differently, from Facebook and Twitter, WhatsApp groups do not have many features that have been pointed out as responsible for the dissemination of false information [19]. WhatsApp does not have ads, promoted tweets, News Feed or timeline, which are controlled by algorithms. In a group chat, anybody can propose a discussion or start a new discussion in response to a piece of content or join an existing discussion at any time and any depth. There is no algorithm or human curator moderating discussions in a WhatsApp group. In such a domain, a natural question that arises is: What are the ingredients of the WhatsApp architecture that makes it a weaponizable social media platform to distribute misinformation? The goal of this paper is to take a first step towards understanding information diffusion in WhatsApp groups. Our work is an essential step in order to increase knowledge about misinformation dissemination in messenger apps. The approach we use to understand information spreading in a WhatsApp group is a combination of two concepts: information cascade and attention. WhatsApp allows a participant to explicitly mention a message she intends to reply or refer to, by using the reply function. The reply function in WhatsApp creates a sequence of interrelated messages, which can be tracked and viewed as a cascade of interrelated messages. Every time a participant "replies" to a message, all other participants are notified by the message that appears on the screen. A reply has the effect of re-gaining the attention for a specific piece of information. In a chaotic environment of a WhatsApp group chat, participants are sometimes swamped by messages, which characterizes a typical information overload situation, that competes for the cognitive resources of the participants. Herbert Simon [10] was the one who first theorized about information overload, proposing the concept of economy of attention. "A wealth of information creates a poverty of attention" said Simon [26]. Attention cascades can be viewed as a structure that represents the process of information creation and consumption, which models new patterns of collective attention. They capture the connections fostered among group participants, their comments and their reactions in the group discussion setting. We want to increase our understanding of information dissemina- tion processes that underly the dynamics of a group discussion. Our initial research questions are the following: • How different are attention cascades in political and non- • What is the impact of false information on the characteristics political groups on WhatsApp? of attention cascades? To illuminate the behavior of attention cascades, we study the dissemination processes of cascades in political and non-political groups as well as cascades with previously reported false informa- tion and with unclassified information. We show that the attention cascades are markedly different in their time evolution and struc- ture. More broadly, by characterizing the attention cascades of different types of groups, we can better understand the information spreading process in group discussions and explore the contextual factors driving their differences. In this paper, we present a large-scale study of attention cascades in WhatsApp groups. Attention cascades can help to understand the process of information dissemination in WhatsApp groups. With an in-depth analysis of a large number of messages of two groups, political and non-political, each containing verified false information and unclassified information, we demonstrate that the structural and temporal characteristics of the two classes of cascades are different. We show that attention cascades in WhatsApp groups reflect real-world events that capture public attention. We also demonstrate that political cascades last longer than non-political ones. We show that cascades with false information in political groups are deeper, broader and reach more users than the same type of cascades in non-political groups. The remainder of this paper is organized as follows. We first re- view related work. Next, we discuss the concept of attention cascade that drives our study and describes each step of our methodology. We present our results for each research question posed, and then discuss our main conclusions and directions for future work. 2 RELATED WORK Characterizing cascades structure and growth on online social net- works is a key task to understand their dynamics. Many studies have analyzed cascades formed on networks like Facebook and Twitter. In [13], authors analyzed large cascades of reshared photos on Facebook, more specifically one cascade of a reshared American President Barack Obama's photo posted on his page following his reelection victory, which in 2013 it had had over 4.4M likes, and another photo posted by a common Norwegian Facebook user (Pet- ter Kverneng), which got one million likes on his humorous post. This paper shows that these two large cascades spread around the world in 24 hours and it points out that studying information cas- cades is important to understand how information is disseminated on today's very well-connected online environment. On the other hand, analyzing Twitter's cascades, the authors of [25] analyzed the cascades from the point of view of users. This paper measures how Twitter users observe the retweets on their own timelines and how is their engagement with retweet cascades in counterpoint with non-retweeted content. Nevertheless, we need to understand cascades' properties on emerging online communication platforms like WhatsApp (which has millions of users organized in groups) to better understand the phenomenon of the quick information spread and its impact on users decisions and actions. Recently, the paper [8] shows how some diffusion protocols af- fect 98 large information cascades of photo, video, or link reshares on Facebook. Authors identify four classes of protocols character- ized by the individual effort for user participates in a cascade and by the social cost of user stays out. The proposed classes, transient copy protocol, persistent copy protocol, nomination protocol, and vol- unteer protocol, may used to understand the cascade growth and structure. This paper indicates that as individual effort increase the information dissemination decreases and as higher the social costs users wait and observe more the group before making a decision or do any action. The cascades can be viewed as complex dynamic objects. Thus, identifying their recurrence and predicting their growth are not trivial tasks. In [6], authors present a framework to address cascade prediction problems, which observe the nature of initial reshares as well as some characteristics of the post, such as caption, language, and content. Moreover, authors of [7] analyze cascades bursts and show how their recurrence would occur over time. Predicting cas- cades growth, evolution, and recurrence could be useful to mitigate Some studies analyzed attention on online platforms. Ciampaglia et al. [10] analyze Wikipedia network traffic to measure the atten- tion span and their spikes through time. They found that collective attention is associated with the law of supply and demand for goods, in this case, information. Moreover, the authors show that the cre- ation of new Wikipedia articles is associated with shifts of collective attention. Wu et al. [28] studies the collective attention towards news story from the political news webiste digg.com. The authors analyze how the group attention shifts considering the novelty of the news and the process of fade with time as they spread among people. Regarding WhatsApp, there are few studies analyzing data ex- tracted from groups. The majority of works explore the WhatsApp effects on education activities. For instance, Cetinkaya [5] inspect the impact of WhatsApp usage on school performance and Bouhnik et al. [4] analyze how students and teachers interact using What- sApp. Other works compare WhatsApp with other applications. Church et al. [9] analyzes the difference of between WhatsApp and SMS messaging and in Rosler et al. [24], authors present a system- atical analysis of security characteristics of WhatsApp and of two other messaging applications. These studies use qualitative method- ologies and data related to (but not directly from) WhatsApp to perform the study. However, few works actually characterize What- sApp usage using its data. Recently, Garimella et al. [15] proposes a data collection methodology and perform a statistical exploration to allow researchers to understand how public WhatsApp groups data can be collected and analyzed. Rosenfeld et al. [23] analyze 6 mil- lion encrypted messages from over 100 users to build demographic prediction models that use activity data but not the content of these messages. In [22], authors collected WhatsApp messages to monitor critical events during the Ghana 2016 presidential elections. the spread of rumors [14] and of misinformation in general, espe- cially in the political context, which has received much attention lately. This paper greatly builds on top of prior study [27], where the authors analyzed the diffusion of verified true and false news stories distributed on Twitter. They classified news as true or false using in- formation from six independent fact-checking organizations. They found that falsehood diffused farther, deeper, and more broadly than the truth in all categories of information, especially for false political news. They also found that false news was more novel than true news and false stories inspired fear, disgust, and surprise in replies, whereas true stories inspired anticipation, sadness, joy, and trust. In our work, we also adjust the methodology proposed in [27] on WhatsApp to analyze cascades properties and user relationships of political and non-political groups. We also analyze and compare cascades with and without identifiable falsehood using the informa- tion on Brazilian fact-checking websites. Nevertheless, we extend the work [27] by applying the methodology on WhatsApp groups that are entirely different online environments when we compare to Twitter or Facebook. Finally, we exploit an attention perspective in our analyses, which brings a somewhat different view of the problem of misinformation dissemination. 3 ATTENTION CASCADES IN WHATSAPP WhatsApp enables one-to-one communication through private chats as well as one-to-many and many-to-many communication through groups, allowing users to send textual and media (image, video, audio) messages. Compared to other online social networking applications (e.g., Facebook, Twitter), WhatsApp may be considered an unsophisticated platform as information is shared through a very loosely structured interface. Shared content is shown in temporal order, with each message accompanied by the posting time and, in case of groups, its origin (identification or telephone of the user who posted it). Yet, WhatsApp is a major communication platform in various countries of the world, offering an increasingly popu- lar vehicle for information dissemination and social mobilization during important events [21]. One important feature of WhatsApp is reply, which allows a user to explicitly mention a message she intends to reply or refer to, bringing it forward in a conversation thread. This kind of inter- action among users mentioning, replying or sharing each other's messages is common in other online social networks (e.g., reply and retweet in Twitter, share and post on Facebook). However, in WhatsApp this feature plays a key role in facilitating navigation through the sequence of messages, allowing one to keep track of different ongoing conversation threads. This is particularly impor- tant in the case of WhatsApp groups, where different subsets of the participating users may engage in different, possibly weakly related (or even unrelated) conversations simultaneously. Thus it becomes hard to keep track of each conversation thread, losing attention and ultimately diverting. Our goal in this paper is to study the information dissemina- tion process in WhatsApp groups, focusing mainly on how user attention, a key channel for such process, is characterized in such unstructured, yet increasingly popular environment. To that end, we use the concept of cascades [27] as a structural representation of how users' attention is dedicated to different conversation threads within a WhatsApp group. We emphasize that conversations in WhatsApp have the distinguishing characteristic of not being influ- enced or driven by any algorithm as in other social networks (e.g., newsfeed in the Facebook, content recommendation, etc.). They depend solely on the active participation of users of the group, as messages posted by others catch their attention. More specifically, an attention cascade begins when a user makes an assertion about a topic in a message to the group. This message is the root of the cascade. Other users join and establish a conver- sation thread by explicitly replying to the root message or to other messages that replied to it. We say that the root or subsequent messages in the cascade caught the attention of a group member, motivating her to interact. Thus, we focus on messages that were explicitly linked by the reply feature1. We consider the specific use of the reply feature as a signal that the user's attention was caught by the message she is replying to and that the cascade is a (semi-)structured representation modeling emergent patterns of collective attention. As in any real conversation of a group of people, attention may drift to other (possibly weakly related) topics as the 1Users may not necessarily use the reply feature to respond to a previous message. However identifying such implicit links would require processing the content of the messages, which is outside the present scope. conversation goes on. Note however that in an explicit reply, the message that is being replied to is shown to everyone, just before the reply itself, serving as a means to "re-gain" or keep (part of) the original attention that motivated the user to participate in the cascade. Thus, the root message triggers the initial attention of some users, and the conversation is kept alive among a subset of participating users (which may change over time) as they continue replying to successive messages. We also note that, unlike prior uses of the cascade model to understand the propagation of a particular piece of content [13, 25], we here use it to represent the participation (thus attention) of multiple users in an explicitly defined conversation thread, despite other messages and conversations that might be simultaneously happening in the same group. Thus, we refer to such structural rep- resentation of how collective attention is dedicated to a particular conversation thread within a WhatsApp group as attention cascade. 4 METHODOLOGY In this section, we describe our methodology to gather data and characterize attention cascades in WhatsApp groups. We analyze cascades concerning three dimensions, namely, structural and tem- poral properties as well as user participation. The first two capture the main patterns describing how collective attention is dedicated to a conversation thread and how it evolves. The latter captures how individuals participate in such process, interacting with each other via replies. Given the extensive use of WhatsApp for discussions related to politics and other social movements [21], we collected data from groups oriented towards political and non-political topics. We define the topic of a cascade as the topic of the group it belongs to, and we analyze political and non-political cascades separately. Similarly, we also analyze cascades with identified false information separately from the rest. In the following, we start by describing our methodology to collect WhatsApp data (Section 4.1), and present how we identify and build cascades from such data (Section 4.2). We discuss our group and cascade labelling method (Section 4.3) and present the attributes used in our characterization (Section 4.4). 4.1 Data Collection We collected a WhatsApp dataset consisting of all messages posted in 120 Brazilian WhatsApp groups from October 16th 2017 to No- vember 6th 2018. Despite offering private chats by default, What- sApp allows group administrators to share invites to join such groups on blogs, web pages, and other online platforms. Such fea- ture effectively turns the access to the group and the content shared in it public since anyone who has the invite can choose to join the group, receiving all the messages posted after that. We focus on groups whose access is publicly available. To find invites to such groups online, we leveraged the fact that all links shared by group administrators have the term chat.whatsapp.com as part of their URLs. Thus, we used Selenium scripts on Google Search website to search for web pages containing this term and located in Brazil (according to Google). We parsed all pages returned as a result of the search, extracting the URLs to WhatsApp groups. The monitoring and data collection process of each group re- quires an actual device and valid SIM card to join the group. Thus we were restricted to join a limited number of WhatsApp groups by the available memory in our devices. We randomly selected and joined 120 groups to monitor. These groups cover different topics which can be further categorized into political oriented subjects or not, as will be discussed in Section 4.3. We then used the same process described in [15] to collect data from those groups, pre- serving user anonymity and complying with WhatsApp privacy policies. Specifically, we extracted the WhatsApp messages from our monitoring devices (smartphones) using scripts provided by the authors2, replacing each unique telephone number by a random unique ID. Throughout the paper, we refer to such a unique ID by the term user3. In total, our dataset consists of 1,751,054 messages posted by 30,760 users engaged in the 120 WhatsApp as mentioned earlier groups 4. 4.2 Attention Cascade Identification Recall that an attention cascade is composed by a tree of messages, which are pairwise connected by the reply feature, posted by one or more users. We identify cascades on WhatsApp by taking the following approach. We model each group as a directed acyclic graph where each node is a message (text or media content) posted in the group and there is a direct edge from message A to message B if message B is a reply to message A5. Each connected component of such a graph, which by definition is a tree, is identified as a cascade. Note that we chose not to impose any time constraint on the cascade identification because we consider the use of a reply as strong evidence of the connection between messages. Thus, all cascade leaves are messages that did not receive any reply (in our dataset). Figure 1: Example of a cascade on WhatsApp. Figure 1 illustrates how we identify cascades from messages posted in a WhatsApp group. Figure 1 (left) shows a sequence of 7 messages. The cascade starts with "MESSAGE 2", the root, which was posted at time 15:35. At time 15:38, another user replied to that 2https://github.com/gvrkiran/whatsapp-public-groups 3We are not able to identify multiple telephone numbers belonging to the same person. 4Readers can contact the first author to request the anonymized dataset used in this work. We would be pleased to provide it. 5Thus, message B was necessarily posted after message A. Programa de Pós-graduação em Ciência da Computação -UFMG1MESSAGE 2Depth01MESSAGE 3MESSAGE 7MESSAGE 52 message by posting "MESSAGE 3", which was then followed by another reply, "MESSAGE 5". At time 15:50, user "You" replied the root message by posting "MESSAGE 7". Note that "MESSAGE 4" and "MESSAGE 6" posted during this time interval do not belong to the cascade as they are not explicit replies to any previous message in the cascade. Moreover, "MESSAGE 1" does not belong to the cas- cade either, since the message was posted before the root message. Moreover, since it did not receive any reply, it does not belong to any cascade. Finally, note that "MESSAGE 7" is a reply made by the same user who posted "MESSAGE 2", thus it is a self-reply. By such an example, it becomes clear that there might be multiple on-going cascades simultaneously in the same group. 4.3 Classifying Groups and Cascades As mentioned, we analyze cascades of different topics, notably political and non-political topics, as well as cascades containing false information separately, aiming at identifying attributes that distinguish them. In this section, we discuss how we label each cascade according to such categorization. WhatsApp groups are identified by names that reflect the gen- eral topic that the discussions in the group should cover. Examples of group names in our dataset (translated to English) are Brazil- ian news, Friendship without borders and Right wing vs. Left wing. Our data collection span several periods of significant social mo- bilization in Brazil. For instance, the 2018 Brazilian general elec- tion, during which WhatsApp was reportedly a significant vehicle of political debates6. Thus, we chose to classify groups into two categories: political oriented and non-political. To that end, we manually labeled the groups according to their names. For instance, group names that refer to specific candidates or political debates were labeled as political groups, whereas all others were labeled as non-political. Out of the three examples above, the first two illus- trate non-political groups, whereas the last one (Right wing vs. Left wing) is clearly politically oriented. Our labeling effort identified 78 political and 42 non-political groups in our dataset. We refer to an attention cascade in a political group as a politi- cal cascade. Similarly, cascades in non-political groups are labeled as non-political. Such definition is a simple cascade categoriza- tion since the specific topic(s) discussed in a cascade may diverge from the group's meant subject. Nevertheless, we argue that, in general, inheriting the group label is a reasonable approximation, and we leave for the future a more specific content-based cascade categorization. Orthogonally, we also distinguish cascades containing report- edly false information (e.g., rumor) or, more generally speaking, falsehood, from the others. To that end, we relied on previously identified fake news reported by six Brazilian fact-checking web- sites (Aos Fatos, Agência Lupa, Comprova, Boatos.org, Checagem Truco, and Fato ou Fake) 7. We first collected all news identified as fake by those six Brazilian fact-checking websites, totalling 3,072 fake news fact-checks. Next, we filtered fake news in text, that is, we removed fact-checks that analyzed fake content only in media formats (audio, video or image). In total, we selected 862 fake news texts. We then turned to the messages in our identified cascades, focus- ing on textual content and URLs shared. The latter often refers to news webpages. Thus, we extracted the texts from those URLs using the newspaper8 Python library, which is specialized to retrieve the textual content of news portals and websites. We discarded all URLs for which the library was not able to recover the text (returned NULL). In total, we identified 337,861 pieces of text on the cascades (327,530 textual messages and 10,331 texts from URLs). For the sake of readability, we refer to all of them as merely text messages. In order to identify text messages with falsehood, we first pro- cessed all fake news and text messages by removing stopwords and performing lemmatization using the Natural Language Toolkit [2]. We then modeled each piece of content (fake news and text mes- sage) as a vector of size n, where n is the number of distinct lemmas identified in all text messages and fake news. Each position in the vector contains the weight of the corresponding lemma, defined as the term frequency (i.e., the number of times that the term appeared in the corresponding text). We compared each text message against each fake news by com- puting the cosine similarity [18] between their vector representa- tions. Specifically, given a text message (vector) m and fake news (vector) f , we computed their textual similarity as: n (cid:113)n (cid:113)n i =1 mi fi similarity(m, f ) = m · f ∥m∥ ∥ f ∥ = i =1 m2 i i =1 f 2 i (1) where mi and fi are the weights in text vectors m and f . The cosine similarity returns a value between 0 and 1. The closer the value to 1, the stronger the similarity between the vectors. In order to reduce noise, we focused on text pairs with similarity above 0.5. We manually inspected each such text pair and identified a total of 677 out of 2271 messages whose textual content referred to fake news reported by Brazilian fact-checking websites. We label any cascade containing at least one of such messages as cascade with falsehood9. We refer to all other cascades as unclassified. Note that we cannot guarantee the absence of falsehood in the unclassified cascades as we only analyzed fake news in text format, and we are restricted by the available fake news in such format reported by fact- checking websites. Nevertheless, we assume that the most popular fake fake news disseminated as textual content were identified and listed by Brazilian fact-checking services. In total, we identified 666 cascades with falsehood (49 non- political and 617 political cascades) and 149,528 unclassified ones (52,689 non-political and 96,839 political cascades). 6Another example was a national truck drivers strike which greatly affected the country with the shutdown of highways in most states which caused unavailability of food and medicine for two weeks in late May 2018. 7https://aosfatos.org/, https://piaui.folha.uol.com.br/lupa/, https://projetocomprova. com.br/,https://www.boatos.org/,https://apublica.org/checagem/,https://g1.globo. com/fato-ou-fake/ 8https://pypi.org/project/newspaper/ 9Although we do not impose restrictions on the depth of such message, we note that in the vast majority of the cases (93%), the root message of such cascades carried false information. Figure 2: Six motifs considered for analysis. Each node is a user and an edge (i, j) represents that a user i replied a user j in a given cascade. 4.4 Cascade Attributes We characterize attention cascades concerning several attributes which can be grouped into three main dimensions: structural prop- erties, temporal properties, and user participation. The structural properties consist of the number of nodes, depth, maximum breadth, and structural virality. The number of nodes corresponds to the total number of messages in the cascade. The depth of a particu- lar message m in a cascade is the number of edges from the root message to m (i.e., number of replies from m back to the root). The depth of a cascade is then defined as the maximum depth reached by a message in the cascade. The breadth of a cascade is defined according to a certain depth and corresponds to the number of mes- sages in that particular depth of the cascade. Thus, the maximum breadth of a cascade is defined based on the breadth at all depth levels in the cascade. The structural virality of a cascade is defined as the average distance between all pairs of nodes [17]. The higher the structural virality value, the stronger the indication that, on average, the messages are distant of each other, thus suggesting viral diffusion of content in that cascade [17]. The main temporal attribute analyzed is the cascade duration, defined as the time interval between the last message belonging to the cascade and its root. We also characterize the temporal evo- lution of each cascade by analyzing its structural properties over time. When analyzing structural and temporal attributes that are in function of another attribute, we normalize their values in order to compare cascades with different values ranges. For example, when we analyze depth over time, we averaged (and measured standard error) at every depth considering the maximum depth of the cas- cade. Thus 50% depth means the depth at the middle of any cascade. Therefore, we can analyze the average number of minutes it took to reach a certain percentage depth in a cascade and compare with others. Regarding the third dimension, user participation, we character- ize each cascade in terms of the number of unique users participat- ing in the cascade as well as the patterns of social communication established by them. For the latter, we first build a user-level repre- sentation of each cascade, that is, we build a directed graph whose vertices are users and an edge between vertice X and vertice Y is added if user X replied to user Y in the given cascade. We identify patterns of social communication occurring between users in such representation using motifs. To that end, we borrow from [29], where the authors proposed network motifs as a tool to analyze pat- terns of information propagation in social networks. The authors proposed four types of motifs (i.e., long chain, ping pong, loop, and star), we here extend the definition by analyzing six motifs, which are shown in Figure 2. Specifically, we propose the self-loop motif and divide the star motif into two other motifs by differentiating it according to its edge orientation (incoming star and outgoing star). Moreover, we choose to rename long chain to chain and ping pong to dyadic. We identify motifs in cascades testing if a cascade graph is iso- morphic to a motif template. We define templates for the motifs in Figure 2 as follows. Self-loop and dyadic motifs are considered templates, as the total number of nodes is fixed (one and two, re- spectively). For the remaining motifs, we generate templates with the number of nodes ranging from 2 (chain) or 3 (loop, outgoing star, incoming star) up to n, where n is the maximum number of unique users in any cascade analyzed. To detect graph isomor- phism, we used the implementation of the VF2 algorithm proposed by Cordella et al. [12] available in the networkx Python library. The VF2 algorithm identifies both graph and subgraph isomorphism. Our analysis considers the presence of a motif in a given cascade if the cascade is a graph (or subgraph) isomorphic to the correspond- ing template. 5 CASCADE CHARACTERIZATION In order to understand the characteristics of the attention cascades as well as the hidden structures existing in the interaction between participants of a group, we adopt a three-dimension approach to characterize attention cascades. To that end, we look at the struc- tural and temporal characteristics of the cascades and the different communication forms that participants of a cascade interact with each other. In the following, we present the analysis and discussion of the findings in each dimension. 5.1 Overall cascade analysis In this section, we look at the number of cascades identified in our dataset of messages. To do so, and rather than viewing the set of all cascades, we segment the cascades into two classes, namely: political and non-political. For each class, we separate the cascades into two sub-classes: cascades with verified false information and unclassified cascades, that may have both true and false information, but it was not verified. Figure 3 shows the total number of cascades in the dataset col- lected from WhatsApp groups during the period from October 2017 to November 2018. As it is evident from Figure 3, there are two peaks of cascades in political groups. These peaks shown in the leftmost graph are associated with key events of the electoral cam- paign in Brazil. One peak occurred when the presidential candidate, Jair Bolsonaro, was stabbed in the stomach during a campaign rally at the beginning of September. The other event was the day of the first round of voting, at the beginning of October. It is worth noting that the peak of the number of political cascades with false information is also associated with the date of the first round of vot- ing, that was widely publicized by the media [3]. The non-political cascades with falsehood remained stable during the election period, as exhibited in the rightmost graph of Figure 3. In the leftmost graph, the peak for non-political cascades occurred by the end of May, coinciding with the truckers' strike that halted Brazil, with protesters blocking traffic on hundreds of highways [20]. These two Programa de Pós-graduação em Ciência da Computação -UFMG1Self-loopDyadicChainLoopOutgoingstarIncomingstarA repliedtoDDrepliedtoA Figure 3: Total cascades over time. Figure 4: Depth, maximum breadth, structural virality, and total messages. graphs clearly show that attention cascades in WhatsApp groups reflect real-world events that capture the public attention. We also analyzed temporal relationships among different cas- cades of each group [1]. We found that in 99.2% of the cases there is no temporal overlap (i.e., one cascade finishes before others start). Therefore, our dataset shows that most of the time only one thread of discussion dominates the attention of the group. 5.2 Structural Characteristics In this section, we focus on the structural characteristics of the cascades, that are defined in section 4.4. Figure 4 shows the CCDF of the empirical distribution of the main structural characteristics of the two classes of cascades, political and non-political and the sub-classes, represented by cascades with false information and un- classified cascades. The upper row shows the comparison between political (dotted) and non-political (regular) groups. The lower row shows the comparison between 'unclassified' (blue) and 'with false- hood' (red), besides the previous segmentation between political and non-political, totaling four lines of distribution. A natural question concerning the structure of attention cascades in different WhatsApp groups is whether they exhibit a similar structural profile. When analyzing the cascades on political and non-political groups (upper row) in Figure 4, we observe that the graphs show similar curves for both classes, with small differences in the probability of the maximum values for the two classes. We observe that non-political cascades are deeper and broader than political cascades. Moreover, despite the structural virality of po- litical and non-political cascades are very similar, when we look at the graph that shows the structural virality of the sub-classes of cascades (lower row), we note that the virality of cascades with false information in political groups is more significant than the virality in a non-political group. Recall that higher virality sug- gests viral diffusion, which maybe interpreted as a sign that false information in political groups spread farther than in non-political groups. Finally, the total number of messages attribute calls our attention since the number of messages in political discussions exceeds the number in non-political discussions, indicating that political subjects stimulate more interaction among participants. Non−Political Political Non−Political Political 05000100001500020000Oct 2017Jan 2018Apr 2018Jul 2018Oct 2018MonthTotal Cascades050100150200Jan 2018Apr 2018Jul 2018Oct 2018MonthTotal Cascades With Falsehood Non−Political Political Unclassified Non−Political Unclassified Political With Falsehood Non−Political With Falsehood Political 10−610−510−410−310−210−1100117334780DepthCCDF10−610−510−410−310−210−1100151032Max−Breadth10−610−510−410−310−210−110017152027Structural Virality10−610−510−410−310−210−110034100172Total Messages10−610−510−410−310−210−1100117334780DepthCCDF10−610−510−410−310−210−1100151032Max−Breadth10−610−510−410−310−210−110017152027Structural Virality10−610−510−410−310−210−110034100172Total Messages Figure 5: Breadth vs. depth and unique users vs. depth of cascades from political and non-political WhatsApp groups. Figure 6: Cascade duration and unique users. Now we analyze the cascade attributes as a function of depth. We observe in Figure 5 that cascades of political groups have on average more users than cascades of non-political groups after 35% of the maximum depth. The cascades in political groups are on average wider than non-political ones after the half of the maxi- mum depth, indicating that cascades of political groups finish with more parallel interactions (branches) than the non-political ones. Regarding misinformation comparison, we note that cascades with falsehood in political groups reach on average more users than the other types of cascades for higher depth. Note that cascades with falsehood of non-political groups have an unstable behavior. The cascades with falsehood of political groups reach on average more people at every depth as the cascades were deepened. 5.3 Temporal Characteristics We now turn our focus to the length of time of the attention cas- cades. The first column of Figure 6 displays the CCDF of the cascade duration. The top graph of the this column shows that political cascades last longer than non-political ones. A possible explanation is that political cascades stir more debate among the participants of the group. The graph at the bottom of the first column of Fig- ure 6 shows the CCDF of the duration of unclassified cascades and cascades with false information. As we can see from the graph, in both types of groups, political and non-political, the presence of false information reduces the duration of the cascades. We conjec- ture that when false information or fake news is identified in the cascade, the participants of the group start losing interest in the discussion and terminate the cascade. Regarding temporal cascade attributes as a function of depth and unique users, we observe on the topmost left graph of Figure 7 that Non−Political Political Unclassified Non−Political Unclassified Political With Falsehood Non−Political With Falsehood Political 1.01.21.41.61.80102030405060708090100Normalized Depth(%)Avg. Uni. Users1.001.251.501.752.000102030405060708090100Normalized Depth(%)Avg. Breadth12340102030405060708090100Normalized Depth(%)Avg. Uni. Users12340102030405060708090100Normalized Depth(%)Avg. Breadth Non−Political Political Unclassified Non−Political Unclassified Political With Falsehood Non−Political With Falsehood Political 10−610−510−410−310−210−1100160720372187822DurationCCDF10−610−510−410−310−210−1100181325Unique Users10−610−510−410−310−210−1100160720372187822DurationCCDF10−610−510−410−310−210−1100181325Unique Users Figure 7: Depth over time and unique users over time of cascades from political and non-political WhatsApp groups. Figure 8: User motifs. cascades in political groups take two times longer than cascades in non-political groups to reach their maximum depth. The topmost right graph indicates that cascades in political groups take consid- erable more time to reach 90% of unique users than non-political groups. Moreover, both graphs are that attention allocation in a WhatsApp group clearly depends on the nature of the content that starts the cascade. One possible explanation is that political discus- sions spur hot debates that last longer. In the lower part of Figure 7, we also note that political cascades with falsehood take longer to reach the maximum depth. However, non-political cascades with falsehood take less time to reach the maximum depth. Although we have not explored the content in messages, we conjecture that political fake news has a significant impact on group discussion and generate more debate than non-political fake news, as shown in the leftmost graph of Figure 7. 5.4 User Participation in Cascades In this section, we focus on the following question: how partici- pants of a cascade interact with the other participants? We analyze the relative frequency of the six motifs that represent the most com- mon patterns of social communication among participants of the cascades. Figure 8 shows that the most common pattern of commu- nication among participants of a cascade is chain, for both political and non-political groups. Chain is the most popular motif in the two classes of groups. The percentage of chain is more than half of the total motifs identified in the cascades. It is interesting to observe that the fraction of self-loops in political groups is two times greater than the percentage of self-loops in non-political groups. Regarding misinformation analysis, the rightmost graph of Figure 8 displays that cascades with falsehood of political groups have a higher per- centage of chain and self-loops than corresponding non-political cascades. One possible explanation for the higher percentage of self-loops is that in political discussions a participant might want Non−Political Political Unclassified Non−Political Unclassified Political With Falsehood Non−Political With Falsehood Political 03060901200102030405060708090100Normalized Depth(%)Avg. Minutes01002000102030405060708090100Normalized Unique Users(%)Avg. Minutes0501000102030405060708090100Normalized Depth(%)Avg. Minutes02004000102030405060708090100Normalized Unique Users(%)Avg. Minutes With Falsehood Unclassified58.3932.785.210.040.293.367.9220.334.290.080.376.99Non−PoliticalPoliticalChainDyadicIncoming StarLoopOutgoing StarSelf LoopChainDyadicIncoming StarLoopOutgoing StarSelf Loop020406080Motif Type% MotifsNon−PoliticalPoliticalChainDyadicIncoming StarLoopOutgoing StarSelf LoopChainDyadicIncoming StarLoopOutgoing StarSelf LoopMotif Type to emphasize or defend her position or idea and makes explicit reference to her previous message in the cascade. Regarding the total number of users participating in cascades, we note on the second column of Figure 6 that cascades in non- political groups reach more users than in political groups. This characteristic indicates that discussions in non-political groups draw more attention than the ones on political groups probably because of their content. Moreover, cascades with falsehood on political groups reach more users than cascades with falsehood on non-political groups. 6 CONCLUSION In this paper we used an extensive set of messages to characterize attention cascades in WhatsApp groups from three distinct perspec- tives: structural, temporal and interaction patterns. We developed a data collection methodology and model each group as a directed acyclic graph, where each connected component is identified as a cascade. In addition to providing a new way of looking at informa- tion dissemination in small groups through the concept of attention, our study has unveiled several interesting findings, regarding polit- ical groups and misinformation. These findings include differences in the structural and temporal characteristics of political groups when compared to non-political groups. We show that cascades with false information in political groups are deeper, wider and reach more users than cascades with falsehood in non-political groups. We demonstrate that political cascades last longer than non-political ones. We also show that attention cascades in What- sApp groups reflect real-world events that capture public attention. Our current and future work is focused on leveraging many of the findings and conclusions presented in this paper along with several dimensions. First, we are looking into using information about content to understand their impact on the structure and temporal characteristics of attention cascades. Questions we want to answer in the future include the following: What kind of content would extend the duration of attention cascades? What is an adequate metric for quantifying attention in a group chat? What is the impact of hate content on the characteristics of attention cascades? Finally, we want to construct tools to generate synthetic attention cascades to model different types of group chats. 7 ACKNOWLEDGEMENTS This work was partially supported by CNPq, CAPES, FAPEMIG and the projects InWeb, MASWEB and INCT-Cyber. REFERENCES [1] James F. Allen. 1983. Maintaining Knowledge About Temporal Intervals. Commun. ACM 26, 11 (Nov. 1983), 832 -- 843. https://doi.org/10.1145/182.358434 [2] Steven Bird, Edward Loper, and Ewan Klein. 2009. Natural language processing with Python. O'Reilly Media Inc., New York, US. [3] Anthony Boadle. 2018. Facebook's WhatsApp flooded with fake news in Brazil election. https://reut.rs/2OLpbZu Accessed at February 18, 2019. [4] Dan Bouhnik and Mor Deshen. 2014. WhatsApp Goes to School: Mobile Instant Messaging between Teachers and Students. Journal of Information Technology Education: Research 13 (2014), 217 -- 231. [5] Levent Cetinkaya. 2017. The Impact of Whatsapp Use on Success in Education Process. The International Review of Research in Open and Distributed Learning 18, 7 (November 2017), 8. [6] Justin Cheng, Lada Adamic, P. Alex Dow, Jon Michael Kleinberg, and Jure Leskovec. 2014. Can Cascades Be Predicted?. In Proceedings of the 23rd Interna- tional Conference on World Wide Web (WWW '14). ACM, New York, NY, USA, 925 -- 936. https://doi.org/10.1145/2566486.2567997 [7] Justin Cheng, Lada A. Adamic, Jon M. Kleinberg, and Jure Leskovec. 2016. Do Cascades Recur?. In WWW (WWW '16). International World Wide Web Confer- ences Steering Committee, Geneva, Switzerland, 671 -- 681. https://doi.org/10. 1145/2872427.2882993 [8] Justin Cheng, Jon M. Kleinberg, Jure Leskovec, David Liben-Nowell, Bogdan State, Karthik Subbian, and Lada A. Adamic. 2018. Do Diffusion Protocols Govern Cascade Growth?. In ICWSM 2018, Stanford, California, USA, June 25-28, 2018. AAAI, Palo Alto, California, U.S., 32 -- 41. [9] Karen Church and Rodrigo de Oliveira. 2013. What's Up with Whatsapp?: Com- paring Mobile Instant Messaging Behaviors with Traditional SMS. In MobileHCI (MobileHCI '13). ACM, New York, NY, USA, 352 -- 361. https://doi.org/10.1145/ 2493190.2493225 [10] Giovanni Luca Ciampaglia, Alessandro Flammini, and Filippo Menczer. 2015. The production of information in the attention economy. Scientific Reports 5, 9452 (2015), 1. https://doi.org/10.1038/srep09452 [11] John Constine. 2018. WhatsApp hits 1.5 billion monthly users. $19B? Not so bad. Retrieved from https://tcrn.ch/2LdlavD. Accessed on February 18, 2019. [12] L. P. Cordella, P. Foggia, C. Sansone, and M. Vento. 2004. A (sub)graph iso- IEEE Transactions on Pat- https: morphism algorithm for matching large graphs. tern Analysis and Machine Intelligence 26, 10 (Oct 2004), 1367 -- 1372. //doi.org/10.1109/TPAMI.2004.75 [13] P. Alex Dow, Lada A. Adamic, and Adrien Friggeri. 2013. The Anatomy of Large Facebook Cascades. In ICWSM. AAAI, Palo Alto, California, U.S., 8. [14] Adrien Friggeri, Lada A. Adamic, Dean Eckles, and Justin Cheng. 2014. Rumor Cascades. In Proceedings of the Eighth International Conference on Weblogs and Social Media, ICWSM 2014, Ann Arbor, Michigan, USA, June 1-4, 2014. AAAI, Palo Alto, California, U.S., 8. [15] Kiran Garimella and Gareth Tyson. 2018. WhatApp Doc? A First Look at What- sApp Public Group Data. In International AAAI Conference on Web and Social Media. AAAI, Palo Alto, California, U.S., 1 -- 8. [16] Jeffrey Gettleman and Hari Kumar. 2018. A Minister Fetes a Convicted Lynch Mob, and Many Indians Recoil. https://nyti.ms/2Obz66O Accessed at February 18, 2019. [17] Sharad Goel, Ashton Anderson, Jake Hofman, and Duncan J. Watts. 2016. The Structural Virality of Online Diffusion. Management Science 62, 1 (2016), 180 -- 196. https://doi.org/10.1287/mnsc.2015.2158 [18] Anna Huang. 2008. Similarity Measures for Text Document Clustering. [19] Mike Isaac. 2018. Facebook Overhauls News Feed to Focus on What Friends and Family Share. https://nyti.ms/2qXYhSv Accessed at February 18, 2019. [20] Marina Lopes. 2018. In Brazil, a truckers' strike brings Latin America's largest economy to a halt. https://goo.gl/obWnNK Accessed at February 18, 2019. [21] Marina Lopes. 2018. WhatsApp is upending the role of unions in Brazil. Next, it may transform politics. Retrieved from The Washington Post (https://goo.gl/ WY6nxZ). Accessed on February 18, 2019. [22] Andrés Moreno, Philip Garrison, and Karthik Bhat. 2017. WhatsApp for Moni- toring and Response during Critical Events: Aggie in the Ghana 2016 Election. In 14th Int'l Conf. on Information Systems for Crisis Response and Management. Collections at UNU, Albi, Ghana. [23] Avi Rosenfeld, Sigal Sina, David Sarne, Or Avidov, and Sarit Kraus. 2018. What- sApp usage patterns and prediction of demographic characteristics without access to message content. Demographic Research 39, 22 (2018), 647 -- 670. https://doi.org/10.4054/DemRes.2018.39.22 [24] Paul Rösler, Christian Mainka, and Jörg Schwenk. 2017. More is Less: How Group Chats Weaken the Security of Instant Messengers Signal, WhatsApp, and Threema. Cryptology ePrint Archive 1, 1 (2017), 1 -- 8. [25] Rahmtin Rotabi, Krishna Kamath, Jon Kleinberg, and Aneesh Sharma. 2017. Cascades: A View from Audience. In WWW (WWW '17). International World Wide Web Conferences Steering Committee, Republic and Canton of Geneva, Switzerland, 587 -- 596. https://doi.org/10.1145/3038912.3052647 [26] Herbert A. Simon. 1971. Designing organizations for an information rich world. In Computers, communications, and the public interest, Martin Greenberger (Ed.). The Johns Hopkins University Press, Baltimore, 37 -- 72. [27] Soroush Vosoughi, Deb Roy, and Sinan Aral. 2018. The spread of true and false news online. Science 359, 6380 (2018), 1146 -- 1151. https://doi.org/10.1126/science. aap9559 [28] Fang Wu and Bernardo A. Huberman. 2007. Novelty and collective attention. Proceedings of the National Academy of Sciences 104, 45 (2007), 17599 -- 17601. https://doi.org/10.1073/pnas.0704916104 [29] Qiankun Zhao, Yuan Tian, Qi He, Nuria Oliver, Ruoming Jin, and Wang-Chien Lee. 2010. Communication Motifs: A Tool to Characterize Social Communications. In Proceedings of the 19th ACM International Conference on Information and Knowledge Management (CIKM '10). ACM, New York, NY, USA, 1645 -- 1648. https: //doi.org/10.1145/1871437.1871694
1504.04712
1
1504
2015-04-18T11:50:54
Towards Detecting Rumours in Social Media
[ "cs.SI", "cs.IR" ]
The spread of false rumours during emergencies can jeopardise the well-being of citizens as they are monitoring the stream of news from social media to stay abreast of the latest updates. In this paper, we describe the methodology we have developed within the PHEME project for the collection and sampling of conversational threads, as well as the tool we have developed to facilitate the annotation of these threads so as to identify rumourous ones. We describe the annotation task conducted on threads collected during the 2014 Ferguson unrest and we present and analyse our findings. Our results show that we can collect effectively social media rumours and identify multiple rumours associated with a range of stories that would have been hard to identify by relying on existing techniques that need manual input of rumour-specific keywords.
cs.SI
cs
Towards Detecting Rumours in Social Media Arkaitz Zubiaga1, Maria Liakata1, Rob Procter1, Kalina Bontcheva2, Peter Tolmie1 {a.zubiaga,m.liakata,rob.procter}@warwick.ac.uk, [email protected], [email protected] 1University of Warwick, UK 2University of Sheffield, UK 5 1 0 2 r p A 8 1 ] I S . s c [ 1 v 2 1 7 4 0 . 4 0 5 1 : v i X r a Abstract The spread of false rumours during emergencies can jeopardise the well-being of citizens as they are mon- itoring the stream of news from social media to stay abreast of the latest updates. In this paper, we describe the methodology we have developed within the PHEME project for the collection and sampling of conversa- tional threads, as well as the tool we have developed to facilitate the annotation of these threads so as to identify rumourous ones. We describe the annotation task con- ducted on threads collected during the 2014 Ferguson unrest and we present and analyse our findings. Our re- sults show that we can collect effectively social media rumours and identify multiple rumours associated with a range of stories that would have been hard to iden- tify by relying on existing techniques that need manual input of rumour-specific keywords. Introduction While the spread of inaccurate or questionable information has always been a concern, the emergence of the Internet and social media has exacerbated the problem by facilitat- ing the spread of such information to large communities of users (Koohang and Weiss 2003). This is especially the case in emergency situations, where the spread of a false ru- mour can have dangerous consequences. For instance, in a situation where a hurricane is hitting a region, or a terror- ist attack occurs in a city, access to accurate information is crucial for finding out how to stay safe and for maximising citizens’ well-being. This is even more important in cases where users tend to pass on false information more often than real facts, as occurred with Hurricane Sandy in 2012 (Zubiaga and Ji 2014). Hence, identifying rumours within a social media stream can be of great help for the development of tools that prevent the spread of inaccurate information. The first step in a study of social media rumours is the identification of an appropriate dataset that includes a di- verse set of stories. To-date, related work has relied on picking out rumours through manual identification of well- known viral stories (Qazvinian et al. 2011; Castillo, Men- doza, and Poblete 2013; Procter, Vis, and Voss 2013), in some cases focusing only on false rumours (Starbird et al. Copyright c(cid:13) 2015, Association for the Advancement of Artificial Intelligence (www.aaai.org). All rights reserved. 2014). In these cases, the authors defined a specific set of keywords that were known to be related to rumourous stories and harvested the tweets containing those keywords. How- ever, the process of carefully defining what rumours are, as well as setting forth a sound methodology to identify ru- mours as an event unfolds, which would enable broader and deeper analysis of this phenomenon, remains unstudied. Our goal within the PHEME project1 is therefore to look closely at how rumours emerge in social media, how they are dis- cussed and how their truthfulness is evaluated. In order to create social media rumour datasets, we propose an alterna- tive way of manually annotating rumours by reading through the timeline of tweets related to an event and selecting sto- ries that meet the characteristics of a rumour. This will en- able not only the identification of a rich set of rumours, but also the collection of non-rumourous stories. The creation of both rumour and non-rumour datasets will allow us to train machine learning classifiers to assist with the identification of rumours in new events, by distinguishing the characteris- tics of threads that spark conversation from rumour-bearing ones. In this paper, we introduce a novel methodology to cre- ate a dataset of rumours and non-rumours posted in social media as an event unfolds. This methodology consists of three main steps: (i) collection of (source) tweets posted dur- ing an emergency situation, sampling in such a way that it is manageable for human assessment, while generating a good number of rumourous tweets from multiple stories, (ii) collection of conversations associated with each of the source tweets, which includes a set of replies discussing the source tweet, and (iii) collection of human annotations on the tweets sampled. We provide a definition of a rumour which informs the annotation process. Our definition draws on definitions from different sources, including dictionar- ies and related research. We define and test this methodol- ogy for tweets collected during the 2014 Ferguson unrest in the United States and present, analyse and discuss the out- come of the annotation task. We conclude the paper by dis- cussing the effectiveness of the methodology, its application to the context of cities, and outline ongoing and future work analysing the evolution of and discussion around rumours in social media. 1http://www.pheme.eu Background Annotation of Rumours While there is a substantial amount of research around ru- mours in a variety of fields, ranging from psychological studies (Rosnow and Foster 2005) to computational analy- ses (Qazvinian et al. 2011), defining and differentiating them from similar phenomena remains an active topic of discus- sion. Some researchers have attempted to provide a solid definition and characterisation of rumours so as to address the lack of common understanding around the specific cate- gorisation of what is or is not a rumour. (DiFonzo and Bor- dia 2007) emphasise the need to differentiate rumours from similar phenomena such as gossip and urban legends. They define rumours as “unverified and instrumentally relevant information statements in circulation that arise in contexts of ambiguity, danger or potential threat and that function to help people make sense and manage risk”. This defi- nition also ties in well with that given by the Oxford En- glish Dictionary (OED): “A currently circulating story or report of uncertain or doubtful truth”2. Moreover, (Guerin and Miyazaki 2006) provide a detailed characterisation of rumours, highlighting the following points about a rumour: (i) it is of personal consequence and interest to listeners, (ii) the truth behind it is difficult to verify, (iii) it gains attention with horror or scandal, and (iv) it has to be new or novel. There is a growing body of research on the analysis of ru- mours in the context of social media. Some researchers have looked at how social media users support or deny rumours in breaking news situations but their results are, as yet, in- conclusive. In some cases it has been suggested that Twit- ter does well in debunking inaccurate information thanks to self-correcting properties of crowdsourcing as users share opinions, conjectures and evidence. For example, (Castillo, Mendoza, and Poblete 2013) found that the ratio between tweets supporting and debunking false rumours was 1:1 (one supporting tweet per debunking tweet) in the case of a 2010 earthquake in Chile. Procter et al. (Procter, Vis, and Voss 2013) came to similar conclusions in their analysis of false rumours during the 2011 riots in England, but they noted that any self-correction can be slow to take effect. In con- trast, in their study of the 2013 Boston Marathon bombings, (Starbird et al. 2014) found that Twitter users did not do so well in telling the truth from hoaxes. Examining three differ- ent rumours, they found the equivalent ratio to be 44:1, 18:1 and 5:1 in favour of tweets supporting false rumours. These results provide evidence that Twitters self- correc- tion mechanism cannot be relied upon in all circumstances, and suggest the need for more research that will help people to judge the veracity of rumours more quickly and reliably. This is the primary goal of the PHEME project and one of the first steps has been to define a methodology for selecting rumours associated with an event. In terms of rumour analysis, we are particularly interested in looking in detail at the conversational features of social media (Meredith and Potter 2013), so once we identify a tweet that introduces a rumour (i.e. the source tweet), we then collect all tweets having a reply relationship with the source tweet, to create a unit of tweets that we call a thread. 2http://www.oxforddictionaries.com/definition/english/rumour We begin by expanding on the OED’s definition with ad- ditional descriptions from rumour-related research, to pro- vide a definition of rumour that is richer and, we argue, more appropriate for our purposes. We formally define a rumour as a circulating story of questionable veracity, which is ap- parently credible but hard to verify, and produces sufficient skepticism and/or anxiety. Previous work on annotation of rumourous stories from tweets (Qazvinian et al. 2011; Procter, Vis, and Voss 2013) has relied on the identification a priori of these stories – i.e., by looking at media reports that summarise and debunk some of the rumours – to define a set of relevant keywords for each rumour, and then filter tweets associated with those keywords. While this approach enables collection of a good number of tweets for each rumour, it does not guarantee the collection of a diverse set of stories associated with an event. Instead, we define keywords that broadly refer to an ongo- ing event, which is not a rumour itself but is expected to spark rumours. Having obtained collections of events, our work focuses on visualising the timeline of tweets associ- ated with an event, to enable identification of rumourous content for a set of stories that is not necessarily known a priori, and that is therefore expected to generate a more di- verse such set. For instance, (Starbird et al. 2014) studied rumours from the 2013 Boston Marathon bombings by man- ually picking three well-known rumourous stories: (i) a girl was killed while running in the marathon, (ii) navy seals or craft security or blackwater agents as perpetrators, and (iii) the crowd misidentifies Sunil Tripathi as a bomber. While these three stories were widely discussed because of their popularity, and might provide a suitable scenario for certain studies, we are interested in identifying a broader set of ru- mourous stories in social media. Hence, we set out to enlist the help of experienced practitioners (i.e., journalists) to read through a timeline of tweets to identify rumours. Annotation Task In this annotation task, the human assessor reads through a timeline of tweets to determine which of these are associated with rumours. Without necessarily having prior knowledge of the rumours associated with a given event, we expect that this approach will let us discover new stories. To facilitate the task, we had to deal with two major issues: (i) the number of tweets tends to be large for any given event, and (ii) a tweet does not always provide enough context to be able to determine whether it is referring to a rumour. To alleviate the task and address (i) we reduced the num- ber of tweets to be annotated, by employing a sampling tech- nique that favours the presence of rumours, yet yields a set of tweets representative of the timeline of stories associated with the event in question. To achieve this, we rely on the characteristics of rumours to sample the data. By definition, a rumour has to generate significant interest within a com- munity of users, which can be straightforwardly measured on Twitter by the number of times a tweet is retweeted. A tweet might introduce questionable information even with- out being shared massively, but it will not become a ru- mour until it is spread and further discussed by many. Hence, we save the timestamp every time the annotator makes a se- lection of rumour or non-rumour for a thread. Figure 2 shows the interface of the tool we developed for the annotation of social media rumours, where the timeline of tweets is visualised, along with the options to annotate a tweet and visualise the associated conversation. The tool also includes an interface that allows the anno- tator to review the result of their annotation. The interface summarises the threads annotated as rumours, as well as the stories they were assigned to, which provides a visual sum- mary of what is annotated as a rumour. This is illustrated in Figure 3. The interface also makes it easy to rename cate- gories and to move threads to a different category. Figure 1: Example of a conversation sparked by a rumourous tweet, with a source tweet, and several tweets replying to it based on this assumption, we sample the tweets that exceed a specific number of retweets. To enrich the inherently limited context of a tweet and address (ii) we look at tweets replying to it. While a tweet might not always help determine whether the underlying story was rumourous at the time of posting, the replies from others in case of a discussion can help provide clarity. Thus, we also collect tweets that reply to source tweets, as we will describe later. This allows us to have threads composed of a source tweet, which provides the starting point of a conver- sation, and a set of tweets which reply to that source tweet. Figure 1 shows an example of a thread. We define each of these threads as the unit of the annotation task. The human annotator has to then look at the source tweet of the thread to determine if it is a rumour, and can optionally look at the conversation it sparked for more context. Rumour Annotation Tool To facilitate the annotation task, we developed a tool that vi- sualises the timeline of tweets associated with an event. The purpose of the tool is to enable annotators to read through the tweets and annotate them as being rumours or non-rumours. Annotators record their selections by clicking on the appro- priate icon next to each source tweet (green tick for a ru- mour, a red cross for a non-rumour, or an orange question mark). Each source tweet is also accompanied by a bubble icon, which the annotator can click on to visualise the con- versation sparked by a source tweet. When the annotator marks a tweet as non-rumourous, the task for that tweet ends there. However, when they mark it as a rumour, the tool asks the annotator to specify the story as- sociated with the rumour corresponding to that source tweet. Assigning a story to a rumour means that they categorise the rumourous tweet as being part of that story; a story is iden- tified by a label that describes it. This way, annotators can group together tweets about the same rumour, and provide a descriptive label denoting what the story is about. This will allow us to study rumourous conversations separately, as well as examine them in the context of other conversations within the same story. In order to analyse the time taken to annotate each of the threads and assess the cost of the task, Figure 3: Interface that allows to revise annotations, rename categories, and move threads to another category Data Collection We use Twitter’s streaming API to collect tweets, using a set of keywords to filter tweets related to a certain ongoing event. We did this during the Ferguson unrest, which took place in Missouri, USA, after a man named Michael Brown was fatally shot by the police. Rumours emerged in social media as people started protesting in the streets of Fergu- son. The event was massively discussed in subsequent days and reported by many different sources in social media. For this event, we tracked the keyword #ferguson from 9th-25th August 2014, which led to the collection of more than 8.7 million tweets. The hashtag #ferguson was selected for data collection as the most widely spread hashtag referring to the event3. In the future we plan to use more sophisticated tech- niques for adaptive hashtag identification such as (Wang et al. 2015), to retrieve a broader dataset. Given the size of this collection of tweets, we filtered it by selecting those tweets that sparked a significant number of retweets, in line with the definition of rumours described above. The threshold for the number of retweets was iden- tified through distributional analysis of retweet counts per 3http://blogs.wsj.com/dispatch/2014/08/18/how-ferguson-has- unfolded-on-twitter/ Figure 2: Rumour annotation tool, with tweets about the Ferguson unrest on the 10th of August collected 262,495 replying tweets this way, an average of 20.8 per source tweet. This allows us to visualise the con- versations indented by levels as is the case in online fora. Results Figure 4: Distribution of retweet counts in the dataset tweet (see Figure 4) and empirical tests with different thresh- olds and was set to 100 retweets for this case. This process makes the dataset more tractable for manual annotation by removing tweets that did not attract significant interest. Fi- nally, to facilitate the annotation task by a native English speaker, we removed non-English tweets. Sampling the Fer- guson tweets following these criteria led to a smaller subset of 12,595 tweets. We refer to these as source tweets. We completed this subset of source tweets by collecting the threads associated with them, i.e., the sets of tweets re- plying to each of the source tweets. Twitter used to have an API endpoint (called related results) that allowed the col- lection of conversations, but this endpoint is no longer avail- able. Thus, we collected conversations by scraping the web page of each of the tweets. This was done iteratively to find even deeper levels of replies (i.e., scraping also the web pages of these replies, to collect replies to those), which en- abled us to retrieve the IDs of replying tweets, and then to collect the content of the tweets through Twitter’s API. We The annotation task was performed by a team of journal- ists, SwissInfo, who are members of one of the PHEME projects partner organisations. To maximise the quality of the annotation, they had discussions within the team during the task. They were instructed to annotate the tweets as be- ing rumours or not by relying on the aforementioned defini- tion of a rumour. The tweets were organised by day, so that clicking on a particular date enabled them to see a timeline of tweets posted that day. The annotation has been performed for four different days in the dataset: 9th, 10th, 13th and 15th of August. These dates were picked as being eventful after profiling the whole dataset day-by-day. This set of annotations amounts to 1,185 source tweets and threads. The task of annotating these 1,185 conversations took nearly 8 hours in total. From the timestamps we saved with each annotation, we computed the average time needed per thread by removing outliers in the top and bottom 5% percentiles. The annotation took an average of 23.5 seconds per thread, with an average of 20.7 seconds for those deemed non-rumours, and 31.8 seconds for those deemed rumours. The rumours took longer to an- notate than non-rumours not only because they need a sec- ond step of assigning to a story, but also because they may also require additional time for the annotator to research the story (e.g. by searching for it on the Web). The annotation resulted in 291 threads (24.6%) being an- notated as rumours. The distribution of rumours and non- rumours varies significantly across days, as shown in Table 1. The number of rumours was relatively small in the first few days, always below 15%, but increased significantly on 15th August, with as many as 45% rumours. Nevertheless, the number of stories that the tweets were associated with is very similar for the 10th, 13th, and 15th, showing that the number of rumourous threads increased dramatically on the 15th, while the number of rumourous stories remained con- stant4. We believe that the main reason that the number of rumourous tweets surged on the 15th is the emergence of the following three rumours that sparked substantial discus- sion and uncertainty: (i) that the name of the policeman who killed Michael Brown was about to be announced, (ii) con- jecturing about possible reasons why the police may have fa- tally shot Michael Brown, including that he may have been involved in robbery, and (iii) claims that a new shooting may have taken place in Ferguson, killing a woman in this case. When we look at the distribution of rumours and non- rumours for different numbers of retweets, we observe that the percentage of rumours decreases slightly for tweets with smaller numbers of retweets (i.e., 27.42% of tweets with at least 250 retweets are rumours, while 24.6% of tweets with 100 or more retweets are rumours). This decreasing trend suggests that the selection of a threshold is suitable for the annotation of rumours. We also believe that 100 is a suitable threshold for this event, although further looking at lower threshold values would help buttress its validity, which we could not test in this case given the popularity of the event and large scale of the dataset. Day 9 Aug 10 Aug 13 Aug 15 Aug Overall Threads Rum. (%) 2 (14.3%) 18 (8.7%) 30 (7.0%) 241 (45.0%) 291 (24.6%) Thread Sizes All Avg. Med. 42 14 16 206 15 430 535 16 16 1,185 31 16.5 16.3 20.5 19.9 Stories 2 13 17 17 42 Table 1: Distribution of rumours and stories across days Examining the rumourous threads for these days in more detail, Figure 5 shows histograms of their distributions across time for the four days under study. These histograms show very different trends for these days. While rumours were quite uniformly distributed on the 13th of August, there were almost no rumours in the first part of the 15th, with a huge spike of rumours emerging in the afternoon. The 291 source tweets ultimately identified as rumours were categorised into 42 different stories. These stories range from very popular and highly discussed stories such as Michael Brown having been involved in a robbery (with 89 threads) or the potential announcement of the police of- ficer involved in the shooting (with 26 threads), to lesser discussed stories such as the Pentagon having supplied St. Louis county police with military-grade weapons (with 1 thread) or the fact that two of the four police departments in Ferguson were trained by Israel (with 1 thread). The fact that 4Note that the total number of stories, 42, does not match the sum of stories in each of the four days, given that some stories were discussed for more than one day, so we count them only once. Figure 6: Distribution of conversation sizes for rumours and non-rumours we performed the annotation by reading through the time- line of tweets has helped identify not only threads, but also a diverse set of stories that would have been lost if annota- tion had been driven by a set of manually predefined stories, especially the not-so-popular stories of which we were un- aware. This enriches the annotated dataset by broadening the set of rumours. Having collected the conversations for each of the source tweets annotated, we also compared the extent to which ru- mours and non-rumours differ in the degree of discussion sparked, by looking at the number of replies they received. We might expect rumours to result in more responses due to being more controversial at the time of posting. Figure 6 shows the distribution of the number of replies in the con- versations for rumours and non-rumours. This distribution shows that rumours do provoke slightly more replies than non-rumours, with a slightly higher median. However, non- rumours often generate as many replies as rumours, poten- tially because of the emotional responses that factual verified information can produce. Discussion and Future Work We have introduced a new definition for rumours and a new method to collect, sample and annotate tweets associated with an event. To implement the method, we have devel- oped an annotation tool. This has allowed us to generate an initial dataset of rumours and non-rumours, which we plan to expand with data from future events. In contrast to re- lated work that predefines a set of rumours and then looks for tweets associated with these, our methodology involves reading through the timeline of tweets to pick out the ones that include rumours and categorise them into stories. This has proven effective for identifying not only a large num- ber of rumourous tweets, but also a diverse set of stories. By looking at 1,185 tweets about the Ferguson unrest in 2014, we have found that 24.6% were actually rumourous and that these can be categorised into 42 different stories. We aim to expand the dataset and come up with a reasonably large set Figure 5: Rumourous source tweets (blue) and replies (orange) across time, with an hour as step size of rumours, as well as non-rumours. We believe that the creation of such an annotated dataset of rumours will help to develop tools that make use of ma- chine learning methods to identify rumourous information posted in social media. The automated identification of ru- mours in social media can in turn be used to help alleviate the spread of misinformation surrounding a situation, which is instrumental in ensuring the well-being of citizens af- fected by the matter in question. Examples of emergency sit- uations in which the early identification of rumours posted in social media can assist citizens to stay safe include, among others, a natural disaster, a terrorist attack, or riots. Another interesting context for the application of such a rumour de- tection tool can be during public health emergencies, where the spread of accurate information can be key to calm a wor- ried public (Hyer et al. 2005). In these situations, citizens need to stay abreast of the latest events to make sure where and how to stay safe in the city, as well as to know the state of certain services such as public transportation. Similarly, reducing the spread of misinformation and emphasising ac- curate information can be extremely useful not only to jour- nalists and others who need to keep citizens informed, but also government staff who need to take the right decisions at the right time to maximise safety within a city. Having collected threads sparked by each of the source tweets manually annotated as rumours and non-rumours, we are developing an annotation scheme to help determine the contribution of each of the tweets in the thread/conversation to the story. This will also allow us to study the effective- ness of Twitter’s self-correcting mechanism, among others, by looking at the evolution of a rumour within associated conversations. To do so, the annotation scheme will look at how each of the tweets supports or denies a rumour, the con- fidence of the author, as well as the evidence provided to back up their statements. The creation of such datasets with annotated conversations will then enable us to develop ma- chine learning and natural language processing tools to deal with misinformation in these situations. Acknowledgments We would like to thank the team of journalists at SwissInfo for the annotation work. This work has been supported by the PHEME FP7 project (grant No. 611233). References [Castillo, Mendoza, and Poblete 2013] Castillo, C.; Men- doza, M.; and Poblete, B. 2013. Predicting information credibility in time-sensitive social media. Internet Research 23(5):560–588. [DiFonzo and Bordia 2007] DiFonzo, N., and Bordia, P. 2007. Rumor, gossip and urban legends. Diogenes 54(1):19– 35. [Guerin and Miyazaki 2006] Guerin, B., and Miyazaki, Y. 2006. Analyzing rumors, gossip, and urban legends through their conversational properties. Psychological Record 56(1). [Hyer et al. 2005] Hyer, R. N.; Covello, V. T.; Organization, W. H.; et al. 2005. Effective media communication during public health emergencies: a who handbook. [Koohang and Weiss 2003] Koohang, A., and Weiss, E. 2003. Misinformation: toward creating a prevention frame- work. Information Science. [Meredith and Potter 2013] Meredith, J., and Potter, J. 2013. Conversation analysis and electronic interactions: method- ological, analytic and technical considerations. In Innova- tive methods and technologies for electronic discourse anal- ysis, 370–393. IGI Global. [Procter, Vis, and Voss 2013] Procter, R.; Vis, F.; and Voss, A. 2013. Reading the riots on twitter: methodological inno- vation for the analysis of big data. International Journal of Social Research Methodology 16(3):197–214. [Qazvinian et al. 2011] Qazvinian, V.; Rosengren, E.; Radev, D. R.; and Mei, Q. 2011. Rumor has it: Identifying misinfor- mation in microblogs. In Proceedings of the Conference on Empirical Methods in Natural Language Processing, 1589– 1599. Association for Computational Linguistics. [Rosnow and Foster 2005] Rosnow, R. L., and Foster, E. K. 2005. Rumor and gossip research. Psychological Science Agenda 19(4). [Starbird et al. 2014] Starbird, K.; Maddock, J.; Orand, M.; Achterman, P.; and Mason, R. M. 2014. Rumors, false flags, and digital vigilantes: Misinformation on twitter af- ter the 2013 boston marathon bombing. In Proceedings of iConference. iSchools. [Wang et al. 2015] Wang, X.; Tokarchuk, L.; Cuadrado, F.; and Poslad, S. 2015. Adaptive identification of hashtags for real-time event data collection. Lecture Notes in Social Networks. [Zubiaga and Ji 2014] Zubiaga, A., and Ji, H. 2014. Tweet, but verify: epistemic study of information verification on twitter. Social Network Analysis and Mining 4(1):1–12.
1909.01826
2
1909
2019-10-24T13:03:49
Status in flux: Unequal alliances can create power vacuums
[ "cs.SI", "physics.soc-ph" ]
Human groups show a variety of leadership structures from no leader, to changing leaders, to a single long-term leader. When a leader is deposed, the presence of a power vacuum can mean they are often quickly replaced. We lack an explanation of how such phenomena can emerge from simple rules of interaction between individuals. Here, we model transitions between different phases of leadership structure. We find a novel class of group dynamical behaviour where there is a single leader who is quickly replaced when they lose status, demonstrating a power vacuum. The model uses a dynamic network of individuals who non-coercively form and break alliances with one-another, with a key parameter modelling inequality in these alliances. We argue the model can explain transitions in leadership structure in the Neolithic Era from relatively equal hunter-gatherer societies, to groups with chieftains which change over time, to groups with an institutionalised leader on a paternal lineage. Our model demonstrates how these transitions can be explained by the impact of technological developments such as food storage and/or weapons, which meant that alliances became more unequal. In general terms, our approach provides a quantitative understanding of how technology and social norms can affect leadership dynamics and structures.
cs.SI
cs
STATUS IN FLUX: UNEQUAL ALLIANCES CAN CREATE POWER VACUUMS A PREPRINT John Bryden∗ School of Biological Sciences Royal Holloway, University of London Egham, TW20 0EX United Kingdon [email protected] Eric Silverman University of Glasgow Glasgow United Kingdom MRC/CSO Social and Public Health Sciences Unit [email protected] Simon T. Powers School of Computing Edinburgh Napier University Edinburgh United Kingdom [email protected] October 25, 2019 ABSTRACT Human groups show a variety of leadership structures from no leader, to changing leaders, to a single long-term leader. When a leader is deposed, the presence of a power vacuum can mean they are often quickly replaced. We lack an explanation of how such phenomena can emerge from simple rules of interaction between individuals. Here, we model transitions between different phases of leadership structure. We find a novel class of group dynamical behaviour where there is a single leader who is quickly replaced when they lose status, demonstrating a power vacuum. The model uses a dynamic network of individuals who non-coercively form and break alliances with one-another, with a key parameter modelling inequality in these alliances. We argue the model can explain transitions in leadership structure in the Neolithic Era from relatively equal hunter-gatherer societies, to groups with chieftains which change over time, to groups with an institutionalised leader on a paternal lineage. Our model demonstrates how these transitions can be explained by the impact of technological developments such as food storage and/or weapons, which meant that alliances became more unequal. In general terms, our approach provides a quantitative understanding of how technology and social norms can affect leadership dynamics and structures. Keywords Leadership dynamics, network analysis, dynamic coevolutionary networks 1 Introduction Recent changes of the law in China and Turkey mean that their current leaders (President Xi Jinping and President Recep Tayyip Erdogan respectively) may hold onto their positions indefinitely. Conversely, in other countries the leader may change relatively often; for instance the UK has had five different Prime Ministers between the years 2007-2019. Among smaller groups some, such as private companies, have a permanent leader while other groups, such as university departments or social societies, have more transient and flexible leadership structures. ∗Corresponding author John Bryden ([email protected]). Status in flux: Unequal alliances can create power vacuums A PREPRINT A notable feature of many human groups is that they often do not explicitly coerce their members to join a hierarchy. Instead, soft power and prestige play a strong role [1, 2], with status being an abstraction of more tangible material resources such as land, food, weapons or other commodities [3]. Status is then voluntarily conferred upon leaders by those they are allied with [4, 5, 3, 6, 7, 8, 9, 2], with many of these alliances being asymmetric [10, 5, 9, 2, 11]. The member with the highest status usually deemed the leader [4, 6, 8, 2], creating hierarchical societies. What is not clear, however, is what factors determine why some groups have no leader, others have transient leaders and yet others have relatively permanent leaders. A notable example of a shift between different forms of leadership dynamics is found from evidence from the Neolithic Era. Before this era, human societies consisted of egalitarian hunter-gatherer groups where material resources such as food were shared relatively equally [12] and leadership roles were facultative and of a temporary duration. There followed a transition to sedentary groups where high-status individuals had more resources but leaders still changed relatively regularly [13]. Finally, hereditary leadership became institutionalised, where the role of a chief was passed down a paternal line, which monopolised most of the resources [14]. Many scholars argue that these shifts were due to social and technological developments, which meant that interactions between individuals became increasingly asymmetric. These asymmetries were likely due to control of agricultural surpluses [15, 16, 17, 18], land [15], ideologies [19], or military units and weapons [14]. In light of this evidence, the model we present here investigates how asymmetry in status interaction can generate the different classes of leadership dynamics observed during the Neolithic Era. Network analysis has proved to be a useful approach for studying the interactions of members of a population [3, 20, 7]. Quantitative study of hierarchical networks studied is usually static in nature and they are presented as snapshots in time [21, 22]. However, members of a population will often change their properties and who they interact with over time. Recently, a number of studies have concentrated on the dynamical properties of networks [23, 24]. To look at the factors behind different types of leadership dynamics, we build on this work to model a dynamic coevolutionary network which incorporates the status of individuals as properties of the nodes and links between individuals representing alliances. 2 Model The model consists of a dynamic network of n individuals and is based on the following five assumptions: 1. individuals are equivalent to one another in every way and are unable to coerce one another to form alliances; 2. each individual has a status level which depends on their associations with others, meaning that status is adjusted according to the status of those who they are linked to; 3. individuals share a proportion of their status amongst those they are linked with; 4. status can be asymmetrically passed from one individual to another; 5. individuals can change who they associate with according to the marginal utility of the associations. Each individual i maintains a status si which translates to how much influence they have within the group. Status acts as a multivariate aggregate of an individual's level of money, prestige (titles, jobs, etc), and ownership (land, valuable resources, etc). We assume that, to participate in society, an individual must maintain relationships where they choose a fixed number (constant for all individuals) of associations with other individuals. Consequently, in our model, each individual is given λ unidirectional 'outgoing' links which are assigned to others in a network. Individuals can have any number of 'incoming' links from others in the network. The statuses of the individuals are updated according to their links in the status update stage, and individuals are then given an opportunity to rewire their links in the rewiring stage. The model is then run forward in time to observe the distribution of status and changes of that distribution amongst the individuals. We especially looked for 'leader' individuals with high status and checked to see whether they were superceded by other leaders. We ran models until patterns of leadership dynamics had stabilised, or for a substantially long time (up to 5 million time steps) to check that new leaders were extremely unlikely to rise to high status. Status update stage: In the model, a proportion of r of each individual's status is shared amongst each of its links (including both incoming and outgoing links). This formalisation of sharing status amongst links is based on Katz's prestige measure [25]. For each link, we calculate that link's status by adding the status contribution from the outgoing individual (for whom the link is outgoing) to the status contribution from the incoming individual. To model unequal alliances we introduce the inequality parameter q which reassigns the link's status back to those linked to unequally. A proportion q of a link's status is assigned to the incoming individual, with a proportion (1 − q) remaining with the outgoing individual. In this formulation, the total amount of status in the model is constant, and because every status is initialised at si = 1.0, the sum always equals n, i.e.,(cid:80) i si = n. Rewiring phase: In order to maximise status, each individual determines the outgoing link which is worth the least value to itself. This link is rewired randomly, with probability w, to an individual with whom they are not currently 2 Status in flux: Unequal alliances can create power vacuums A PREPRINT Figure 1: A plot of the network showing a single individual with a high level of status compared to the others. Individuals with higher status are lighter coloured and have larger circles. linked. The assumption of random rewiring reflects the fact that an individual is unlikely to be able to tell the value of an association with another until they have formed the link. 3 Results In the following, we will present our analysis of the dynamics that result from the interplay between the processes outlined above. Simulations were run of the model choosing parameter values over a complete range. Depending on the parameters, we either observe relatively equal statuses among the population, or a relatively high status level for one or a few individuals. An example of a typical network with a single dominant individual can be seen in Fig. 1. A key parameter in the model is the inequality parameter (q), which models an unequal transfer of status from a link originator to a link receiver. This parameter can represent how social and technological development in the Neolithic Era created inequalities in interactions. As we increase q, theory predicts different phases of dynamics in the model, which are shown in Fig. 2. We dub the individual with the highest level of status as the leader. We find three different types of leadership dynamics in the model: No leader, transient leader(s), and permanent leader(s). The dynamics shown in Fig. 2 panel B indicate that as one leader is removed, this can create a power vacuum which leads to a new leader quickly gaining status. We have produced a video animation of the model of this phase of the model which is available at www.youtube.com/watch?v=LrQWDhjwsYA. To investigate how the model transitions in and out of this phase, we looked in more detail at how the numbers of leaders and the lengths of time that they were leaders varied over different levels of the inequality parameter (q). We calculated the distributions of the different numbers of leaders over a threshold status level (si > 3.0) and the median length of time new leaders stay over the threshold after they have become the highest status individual. These are plotted in Fig. 3 with varying numbers of links originating from each individual (λ). The plot demonstrates there are ranges of the inequality parameter (q) where leader turnover is relatively high, but the number of leaders is relatively constant. This shows that there is a power-vacuum effect in our model. To understand the dynamics created by the model in more detail, we compare them to a simpler model of a branching process. Branching processes specify the rates at which an individual with xi links acquires or loses links. In such processes, we observe a power-law distribution of the number of links when the link gain rate is close to the loss rate. We observe such a power law distribution when this is the case in our model (see Fig. 4, panel A). The formation of a hump in the distribution to the right is also consistent with branching processes with a reflecting boundary. However, the results suggest our model is not simply a superposition of branching processes for each individual. A superposition would not explain why we find a power vacuum effect, where there is always a leader which changes identity over time (see, e.g., Fig. 3, q = 0.532, λ = 3). The reason the power vacuum happens is because the presence of a leader suppresses the others (see Fig. 4 panel B), which is due to the relatively high number of links to the leader. 3 Status in flux: Unequal alliances can create power vacuums A PREPRINT Figure 2: Increasing the inequality takes the model through five different phases. First there is effectively no leader at all (panel A). Then we see that a single individual can rise to a high leadership status, but this is transient and leaders are replaced by other individuals (panel B). The length of time that individuals stay as leader then increases as we increase q until the leader is effectively permanently in charge (panel C). In the next phase, a second individual can rise to a high status alongside the first leader, but these individuals' leadership position is transient (panel D). Finally, two individuals share leadership status and remain so permanently (panel E). The value of q is shown, other parameters are r = 0.2, n = 50, λ = 3, w = 0.5. 4 Status in flux: Unequal alliances can create power vacuums A PREPRINT Figure 3: During transient periods, as one leader loses status, another quickly replaces it. Increasing the inequality parameter increases the time that leaders stay above the status level. The lines in panel A show the mean numbers of leaders over a threshold status level throughout a complete run of the model. For each value of q, vertical boxes indicate the relative proportion of timesteps with each number of leaders, for instance the width of ≈ 0.98 at q = 0.532 and λ = 3 indicates that there was generally only one leader above the threshold throughout the simulation. Panel B shows the mean time that an individual stays above the threshold after they have reached highest status.Leader turn over was quite high at q = 0.532 with the average leader lasting 7000 time steps with simulations run over 2 million time steps. Parameters as in Fig. 2 unless shown. In order to check whether our model is consistent with evidence from the Neolithic Era, we looked to see if the increase in leadership time-length is consistent over a wide range of parameters and that our results can be found in large groups. We ran simulations over a wide range of parameters to investigate the role of each parameter on the dynamics. Over each simulation run, we recorded the number of times there was a change of leader. We counted new leaders when they hadn't been one of the previous l − 1 leaders. Our results confirm that as we increased the inequality parameter, we recorded fewer leaders as individuals spend longer time periods as leader. The full range of parameters are presented in the Supplementary Material (see Figures S1-9). 4 Discussion The model presented here demonstrates a rich set of leadership structure dynamics amongst individuals in a non-coercive environment. The model reveals an interesting phase where competition to be leader is suppressed by the temporary presence of one leader, meaning that when a leader loses status it will be quickly replaced. We show how the dynamics can depend on the level of inequality of alliances between individuals, and on the numbers of alliances an individual can form. This suggests that technology and social norms can modulate such a system and implies that self-organisation in a society can play a role in keeping a system near to an equilibrium point where leadership changes relatively frequently. This work pushes forward our understanding of hierarchies in human networks. This is currently largely based on static networks which are formed by preferential-attachment where nodes are more likely to connect to other nodes which 5 Status in flux: Unequal alliances can create power vacuums A PREPRINT Figure 4: Frequency distributions of the numbers of links to individuals demonstrate how individuals show critical behaviour of a branching process over a range of values of q (panel A. There is a truncated power law distribution with exponent ≈ −8.0 on panel A at a relatively low level of q = 0.525. At higher levels of q we can see how dominant individuals will suppress others to subcritical behaviour (panel B). We can see how the rewiring of links to an extra leader between q = 0.54 and q = 0.55 (see Fig. 3 panel A) suppresses the frequencies of individuals with mid-range number of links as q is increased. Parameters are the same as in Fig. 2, q as shown. Simulations were run over 2 million time steps. are already of high status [22]. Our model presents an alternative where the hierarchy is dynamic: nodes have high numbers of connections (alliances) at some points and then other nodes take over. This work also contributes new insights into the Neolithic transitions in human societies from relatively flat power structures, through a period where leaders changed over time, to dominant institutionalised leaders [13]. Our model presents a potential explanation for this, given that status would be closely linked to control of food or other mo- nopolisable resources. Contemporary to the political transitions were innovations in agriculture, which enabled a high status individual to control a large food surplus. These high status individuals were able to feed a large number of supporters at relatively little cost to themselves, for example funding a military, enabling them to maintain and eventually institutionalise their power. Monopolisable resources could also be less tangible, such as religious authority [19] however the evidence suggests these changes followed technological advances [26]. In either case, the growth of population size and the transition to a sedentary, agricultural, lifestyle would have made it more difficult for followers to leave their group and hence easier for a dominant individual to monopolise [15, 27]. These factors, especially the ability to monopolise resources, relate to a high level of the inequality parameter (q) in our model as the leader individual is able to form alliances where they exchange a small proportion of these resources to gain loyalty from their supporters. The three phases of human leadership dynamics correspond to three phases identified in the organisational psychology literature. Lewin has identified three modes of leadership: Laissez Faire, Democratic and Autocratic [28]. In this analysis, the Laissez Faire mode was found to be the case where there is no central resource to coordinate and corresponds to the no-leader phase. When there is a central resource, our model predicts that those individuals with higher status are able to control this central resource, and thus not lose out when more individuals join their group. This is because a controlled surplus of this central resource enables a leader to pay off many individuals and maintain their leadership [29]. The ability to control a central resource means that such groups will switch from the Laissez Faire mode to more Democratic and Autocratic modes. In this paper we focussed primarily on applying this model to develop insights regarding the Neolithic transitions from flat power structures to hierarchical societies. Future work can build upon these foundations to examine whether this 6 Status in flux: Unequal alliances can create power vacuums A PREPRINT model can be applied to other changes in societal structure, such as the movements from monarchy toward parliamentary democracies in 18th-century Europe, or the transitions of Roman civilization betwween monarchy, through annually electing two concurrent consuls in the Roman Republic, to a single Imperator Caesar in the Roman Empire. Other work might investigate the impact of relaxing some of our assumptions. For instance, exploring different rewiring rules where individuals have different numbers of links, or rewire to others based on a similar or higher levels of status or numbers of links. The model also can be extended in various ways to better represent the real-world contexts in which leadership dynamics operate; these could include representations of technological innovations, changes in social norms, or power struggles between potential leaders. These extensions would enable us to develop the model further into a powerful exploratory tool for human leadership dynamics. References [1] Robert M. Sapolsky. Social Status and Health in Humans and Other Animals. Annual Review of Anthropology, 33(1):393 -- 418, September 2004. [2] Mark Van Vugt and J. M. Tybur. The evolutionary foundations of status hierarchy. Handb Evol Psychol (2), pages 788 -- 809, 2015. [3] Nan Lin. Social Capital: A Theory of Social Structure and Action. Cambridge University Press, May 2002. [4] Patricia H. Hawley. The Ontogenesis of Social Dominance: A Strategy-Based Evolutionary Perspective. Develop- mental Review, 19(1):97 -- 132, March 1999. [5] Joseph Henrich and Francisco J Gil-White. The evolution of prestige: freely conferred deference as a mechanism for enhancing the benefits of cultural transmission. Evolution and Human Behavior, 22(3):165 -- 196, May 2001. [6] Felicia Pratto, Jim Sidanius, and Shana Levin. Social dominance theory and the dynamics of intergroup relations: Taking stock and looking forward. European Review of Social Psychology, 17(1):271 -- 320, January 2006. [7] Manuel Castells. Network Theory A Network Theory of Power. International Journal of Communication, 5(0):15, April 2011. [8] Alan Page Fiske and Tage Shakti Rai. Virtuous violence: Hurting and killing to create, sustain, end, and honor social relationships. Cambridge University Press, 2014. [9] Joseph Henrich. The secret of our success: how culture is driving human evolution, domesticating our species, and making us smarter. Princeton University Press, 2015. [10] Peter M. Hall. Asymmetric relationships and processes of power. Studies in symbolic interaction, 1:309 -- 344, 1985. [11] Kay E Holekamp and Eli D Strauss. Aggression and dominance: an interdisciplinary overview. Current Opinion in Behavioral Sciences, 12:44 -- 51, December 2016. [12] Adrian V. Jaeggi and Michael Gurven. Reciprocity explains food sharing in humans and other primates independent of kin selection and tolerated scrounging: a phylogenetic meta-analysis. Proceedings of the Royal Society B: Biological Sciences, 280(1768):20131615, October 2013. [13] Ofer Bar-Yosef. From Sedentary Foragers to Village Hierarchies: The Emergence of Social Institutions. Proceed- ings of the British Academy, 110:1 -- 38, 2001. [14] Timothy K. Earle. How chiefs come to power: The political economy in prehistory. Stanford University Press, 1997. [15] Robert L. Carneiro. A Theory of the Origin of the State: Traditional theories of state origins are considered and rejected in favor of a new ecological hypothesis. Science, 169(3947):733 -- 738, August 1970. [16] Alain Testart, Richard G. Forbis, Brian Hayden, Tim Ingold, Stephen M. Perlman, David L. Pokotylo, Peter Rowley-Conwy, and David E. Stuart. The significance of food storage among hunter-gatherers: Residence patterns, population densities, and social inequalities [and comments and reply]. Current anthropology, 23(5):523 -- 537, 1982. [17] James L. Boone. Competition, conflict, and the development of social hierarchies. Evolutionary ecology and human behavior, pages 301 -- 337, 1992. [18] Kaplan, Hillard S., Hooper, Paul L., and Gurven, Michael. The evolutionary and ecological roots of human social organization. Philosophical Transactions of the Royal Society B: Biological Sciences, 364(1533):3289 -- 3299, November 2009. 7 Status in flux: Unequal alliances can create power vacuums A PREPRINT [19] Jacques Cauvin, Ian Hodder, Gary O. Rollefson, Ofer Bar-Yosef, and Trevor Watkins. The Birth of the Gods and the Origins of Agriculture by Jacques Cauvin, translated by Trevor Watkins (New Studies in Archaeology.) Cambridge: Cambridge University Press, 2000; ISBN 0-521-65135-2 hardback £37.50 & $59.95 Reviewed by Ian Hodder, Gary O. Rollefson, Ofer Bar-Yosef with a response by Trevor Watkins. Cambridge Archaeological Journal, 11(1):105 -- 121, April 2001. [20] Bruno Latour. Reassembling the Social: An Introduction to Actor-Network-Theory. Clarendon Lectures in Management Studies. Oxford University Press, Oxford, New York, September 2007. [21] John F. Padgett and Christopher K. Ansell. Robust Action and the Rise of the Medici, 1400-1434. American Journal of Sociology, 98(6):1259 -- 1319, May 1993. [22] Réka Albert and Albert-László Barabási. Statistical mechanics of complex networks. Reviews of modern physics, 74(1):47, 2002. [23] Thilo Gross and Bernd Blasius. Adaptive coevolutionary networks: a review. Journal of the Royal Society Interface, 5(20):259 -- 271, 2008. [24] John Bryden, Sebastian Funk, Nicholas Geard, Seth Bullock, and Vincent AA Jansen. Stability in flux: community structure in dynamic networks. Journal of The Royal Society Interface, 8(60):1031 -- 1040, 2011. [25] Leo Katz. A new status index derived from sociometric analysis. Psychometrika, 18(1):39 -- 43, 1953. [26] Harvey Whitehouse, Pieter François, Patrick E. Savage, Thomas E. Currie, Kevin C. Feeney, Enrico Cioni, Rosalind Purcell, Robert M. Ross, Jennifer Larson, and John Baines. Complex societies precede moralizing gods throughout world history. Nature, 568(7751):226, 2019. [27] Simon T. Powers and Laurent Lehmann. An evolutionary model explaining the Neolithic transition from egalitari- anism to leadership and despotism. Proceedings of the Royal Society B: Biological Sciences, 281(1791):20141349, September 2014. [28] Kurt Lewin, Ronald Lippitt, and Ralph K. White. Patterns of Aggressive Behavior in Experimentally Created "Social Climates". The Journal of Social Psychology, 10(2):269 -- 299, May 1939. [29] Bruce Bueno de Mesquita, Alastair Smith, James D. Morrow, and Randolph M. Siverson. The Logic of Political Survival. MIT Press, 2005. Google-Books-ID: 1PlRlcgQdpMC. 8
1312.4511
2
1312
2016-02-22T16:45:21
Who Watches (and Shares) What on YouTube? And When? Using Twitter to Understand YouTube Viewership
[ "cs.SI", "physics.soc-ph" ]
We combine user-centric Twitter data with video-centric YouTube data to analyze who watches and shares what on YouTube. Combination of two data sets, with 87k Twitter users, 5.6mln YouTube videos and 15mln video sharing events, allows rich analysis going beyond what could be obtained with either of the two data sets individually. For Twitter, we generate user features relating to activity, interests and demographics. For YouTube, we obtain video features for topic, popularity and polarization. These two feature sets are combined through sharing events for YouTube URLs on Twitter. This combination is done both in a user-, a video- and a sharing-event-centric manner. For the user-centric analysis, we show how Twitter user features correlate both with YouTube features and with sharing-related features. As two examples, we show urban users are quicker to share than rural users and for some notions of "influence" influential users on Twitter share videos with a higher number of views. For the video-centric analysis, we find a superlinear relation between initial Twitter shares and the final amounts of views, showing the correlated behavior of Twitter. On user impact, we find the total amount of followers of users that shared the video in the first week does not affect its final popularity. However, aggregated user retweet rates serve as a better predictor for YouTube video popularity. For the sharing-centric analysis, we reveal existence of correlated behavior concerning the time between video creation and sharing within certain timescales, showing the time onset for a coherent response, and the time limit after which collective responses are extremely unlikely. We show that response times depend on video category, revealing that Twitter sharing of a video is highly dependent on its content. To the best of our knowledge this is the first large-scale study combining YouTube and Twitter data.
cs.SI
cs
Adiya Abisheva, Venkata Rama Kiran Garimella, David Garcia, Ingmar Weber: Who Watches (and Shares) What on YouTube? And When? Using Twitter to Understand YouTube Viewership In Proceedings of the 7th International ACM Conference on Web Science and Data Mining 2014 Who Watches (and Shares) What on YouTube? And When? Using Twitter to Understand YouTube Viewership Adiya Abisheva, Venkata Rama Kiran Garimella, David Garcia, Ingmar Weber Abstract By combining multiple social media datasets, it is possible to gain insight into each dataset that goes beyond what could be obtained with either individually. In this paper we combine user-centric data from Twitter with video-centric data from YouTube to build a rich picture of who watches and shares what on YouTube. We study 87K Twitter users, 5.6 million YouTube videos and 15 million video sharing events from user-, video- and sharing-event-centric perspectives. We show that features of Twitter users correlate with YouTube features and sharing-related features. For example, urban users are quicker to share than rural users. We find a superlinear relationship between initial Twitter shares and the final amounts of views. We discover that Twitter activity metrics play more role in video popularity than mere amount of followers. We also reveal the existence of correlated behavior concerning the time between video creation and sharing within certain timescales, showing the time onset for a coherent response, and the time limit after which collective responses are extremely unlikely. Response times depend on the category of the video, suggesting Twitter video sharing is highly dependent on the video content. To the best of our knowledge, this is the first large-scale study combining YouTube and Twitter data, and it reveals novel, detailed insights into who watches (and shares) what on YouTube, and when. 1 Introduction On July 11, 2013, @justinbieber tweeted: "so many activities it is making my head spin! haha http: //t.co/Gdg615ZZGX", sharing a link to a short YouTube movie clip. In one day, the video received more than 100,000 views, and its owner commented: "So I checked my email today to find 500 new mail... WTF I thought.... 5 mins later I discover that Justin Bieber has tweeted this video...". The viewers of that video came from the 40 million followers that Justin Bieber has in Twitter, including large amounts of pop-loving teenagers that retweeted the video link more than 800 times in the following days. The above example illustrates how the combination of Twitter and YouTube data provide insights on who watches what on YouTube and when. In this article we combine large datasets from both online communities, aiming at a descriptive analysis of the demographics and behavioral features of YouTube viewership through Twitter video shares. In our analysis, the "who" refers to the identity of Twitter users, as displayed on their public profile. We quantify this identity in three facets: a) demographic variables such as gender and location, b) social metrics that include reputation and impact metrics in the Twitter follower network, and c) personal interests and political alignment inferred from profile descriptions and followed accounts. The "what" refers to features of the videos, including i) the YouTube category, and 1/25 Adiya Abisheva, Venkata Rama Kiran Garimella, David Garcia, Ingmar Weber: Who Watches (and Shares) What on YouTube? And When? Using Twitter to Understand YouTube Viewership In Proceedings of the 7th International ACM Conference on Web Science and Data Mining 2014 ii) the popularity of videos in terms of views or likes. The "when" is the time lapsed between the creation of a video and its sharing in Twitter, measuring the time component of individual and collective reaction patterns to YouTube videos. With a combined dataset of Twitter data and YouTube videos we can answer questions about the inter- action between both communities. First, we explore the purpose of social sharing, distinguishing regular and promotional Twitter accounts linked to a particular YouTube channel. We then analyze to which extent the content of the videos watched by a user is similar to their interests on Twitter. Using fea- tures extracted from Twitter, we are able to quantify factors such as social sharing and influence and infer their effect on the videos consumed on YouTube. We also look at the role of political alignment in YouTube video sharing, comparing the shared topics and reaction patterns of individuals depending on their political activity on Twitter. We analyze the times between video creation and social sharing, looking for factors that mediate the speed of video sharing. We find the demographics of users that share videos earlier than the rest, and compare how different categories elicit faster or slower reactions in Twitter. Finally, we explore the relation between the early Twitter shares of a video and its final popularity. To do so, we designed a model that includes social impact and reputation metrics of the early watchers of the video, providing early forecasts of a video's ultimate popularity. 2 Related Work Since we answer "who?", "what?" and "when?", we describe related work done on Twitter profiles and online demographics, YouTube viewership and content and temporal behaviour patterns. 2.1 Online Demographics Related work on "who" does "what" in Web search has been done in Weber and Jaimes [38] where authors analyze query logs of 2.3 million users form a web search US engine. Even though our work performs analysis on Twitter and YouTube users rather than Web search users, methodology used in pre- vious study is of high relevance for our research. More closely related work on Twitter demographics was performed in Mislove et al. [26] where authors investigate whether Twitter users are a representative sample of society. By using (optionally) self-reported and publicly visible data of Twitter users, authors compared demographics of Twitter US users to the US population along three axes. On the geographi- cal dimension, findings showed that Twitter users are overrepresented in highly populated US counties and underrepresented in sparsely populated regions due to different patterns of adoption of social media across regions. Across gender, the male Twitter population is greater than female especially among early Twitter adopters, but male bias decreases as Twitter evolves. On race/ethnicity authors show the distri- bution is highly geographically-dependent. Another study on demographics by Goel et al. [16] shows 2/25 Adiya Abisheva, Venkata Rama Kiran Garimella, David Garcia, Ingmar Weber: Who Watches (and Shares) What on YouTube? And When? Using Twitter to Understand YouTube Viewership In Proceedings of the 7th International ACM Conference on Web Science and Data Mining 2014 that user demographics (age, gender, race, income etc.) can be inferred from Web browsing histories. Fi- nally, Kulshrestha et al. [22] investigate the role of offline geography in Twitter and conclude that it has a significant role in social interactions on Twitter with more tweets and links exchanged across national boundaries. 2.2 Research on Twitter Data Apart from demographics, Twitter has also been studied from other perspectives: prediction of trends/hashtags [2, 34, 19]; notions of influence in Twitter [6] and using Twitter predictive data for elec- tions and discovering political alignment of users [8, 9]. Asur et al. [2] studied trending topics/hashtags and discovered that the content of a tweet and retweeting activity rather than user attributes such as in- fluence, number of followers and frequency of posting are the main drivers for spotting the trend and keeping it alive. In Wang and Huberman [34] a model for attention growth and persistence of trends is presented and is validated on trending topics in Twitter. In another work on trending topics, hash- tags in Twitter can be clustered according to the temporal usage patterns of the hashtag: before, during and after peak of its popularity. Furthermore, the class of the hashtag correlates with social semantics of content associated with the hashtag (Lehmann et al. [24]). In a study on differences of search ac- tivity of trending topics in the Web and Twitter, Kairam et al. [19] reveal that information-seeking and information-sharing activity around trending events follows similar temporal dynamics, but social media leads Web search activity by 4.3 hours on average. More generalized study on differences between Web and Twitter search by Teevan et al. [32] found that timely and social information are primary drivers for searching on Twitter, compared to more navigational search on the Web; Twitter search is more used to monitor new content, while search on the Web is performed for developing and learning about a topic. Another perspective is the notion of influence in Twitter using followers, retweets and mentions studied by Cha et al. [6] with main finding that having a lot of followers does not necessarily mean having a high influence. Another line of work uses Twitter to monitor political opinions, increase political mobi- lization, and possibly predict elections' results. Conover et al. [9] present several methods to discover political alignment of Twitter users by analysing the network of political retweets and hashtags usage. In subsequent work [8], authors go beyond discovering political groups in Twitter, and analyse interaction dynamics of politically aligned subcommunities. Their findings show that right-leaning Twitter users produce more political content, spend a greater proportion of their time for political conversation and have more tightly interconnected social structure which leverages broad and fast spread of information. 2.3 YouTube Video Consumption Ulges et al. [33] use YouTube concepts to predict demographic profile of viewers and also try to use demographics estimated from views statistics to predict the concepts of a video. They show that the use of demographic features improves the quality of prediction. Concerning YouTube video views, researchers 3/25 Adiya Abisheva, Venkata Rama Kiran Garimella, David Garcia, Ingmar Weber: Who Watches (and Shares) What on YouTube? And When? Using Twitter to Understand YouTube Viewership In Proceedings of the 7th International ACM Conference on Web Science and Data Mining 2014 have analyzed time series [11], and predicted the final views count based on properties of growth on YouTube [31]. For instance, Crane and Sornette [11] perform analysis of collective responses to YouTube videos through their time series of views. Among the classes, the most usual were videos that have a fast decaying amount of views, receiving negligible amounts of views soon after their creation. Laine et al. [23] highlighted the role of exogenous factors (such as interest groups) in the activity of YouTube viewers and Qiu et al. [29] suggested two different mechanisms that drive YouTube viewership: popularity and quality filtering. On popularity of videos in YouTube, Figueiredo et al. [12] found copyright videos gain 90% of their views early in lifetime compared to top listed YouTube or randomly chosen videos; top listed videos show quality popularity dynamics pattern opposed to copyright and random videos exhibiting viral, word-of-mouth, dynamics. And finally, related videos and internal search are most contributing towards content dissemination, but for random videos social link is also a key factor. On politics in YouTube, recent work by Garcia et al. [14] performs analysis of collective responses to the YouTube videos of US political campaigns and reveals differences in collective dynamics that suggest stronger interaction among right-leaning users. Weber et al. [36] use YouTube video tags and conclude that general YouTube videos are not polarized in terms of audience, but for subclasses of apolitical videos (e.g., tagged as "army") an audience bias can be predicted (right-leaning in this case). Finally, in Crane et al. [10] collective responses to the videos of Saddam Hussein's death show an extremely fast response and relevance of news and politics for YouTube viewers. 2.4 On Human Behaviour Since our analysis involves the "when" dimension of video shares on Twitter, we review work on tem- poral patterns in human behaviour. Quantitative understanding of human behavior, also known as hu- man dynamics, got a new turning point in 2005 after work by A.-L. Barabási [3], where author looked whether the timing of human activities follows any specific pattern. Results showed that there are bursts of intensive activity interchanged with long periods of inactivity (Pareto distribution) rather than events happening at regular time intervals (Poisson). Since 2005 more studies on the inhomogeneous nature of temporal processes in human dynamics have been performed [10, 20, 39]. Various proxies were used to get timing of human activity, e.g., mobile records, web server logs, SMS etc. Recent study by Wu et al. [39] suggests time patterns follow bimodal distribution with bursts of activity explained by power-law distribution in the first mode and exponentially distributed initiation of activity in the second mode. 3 Data Set We collected data from Twitter and YouTube for our analysis, and related the datasets by looking at instances where links to videos were shared on Twitter. This section describes how we obtained the 87K Twitter users, 5.6 million YouTube videos, and 15 million video sharing events we analyzed in 4/25 Adiya Abisheva, Venkata Rama Kiran Garimella, David Garcia, Ingmar Weber: Who Watches (and Shares) What on YouTube? And When? Using Twitter to Understand YouTube Viewership In Proceedings of the 7th International ACM Conference on Web Science and Data Mining 2014 greater detail. Data sets are available at http://web.sg.ethz.ch/users/aabisheva/2013_ YouTube_Twitter_ETH_QCRI/index.html. 3.1 Twitter The data acquisition starts with a 28 hour time slice from 6/6/2013 21:00 to 8/6/2013 1:00 (AST) of all public Tweets containing any URL provided by GNIP, a reseller of Twitter data. Of these tweets, only tweets by users with at least one follower, one friend, has non-empty profile location and English as profile language were considered. 1,271,274 tweets containing a URL from http://www.youtube. com or http://youtu.be where identified. URLs shortened by Twitter's default URL shortener t.co were automatically unshortened, but other services were not considered. From this set, 200K distinct tweets were sampled uniformly at random. These tweets account for 177,791 distinct users. Out of these, 100K users were sampled uniformly at random. For each of these users we obtained (up to) their last 3,200 public tweets. In 12,922 cases this failed because the user account had been removed or made private. Along with the tweets, we obtained the user's public profile, containing the user-defined location, their followers and friends count and the set of (up to) 5,000 friends (= other Twitter users the user follows) and 5,000 followers (= other Twitter users who follow this user). 96.8% of our users had less than 5,000 followers and 98.9% had less than 5,000 friends. We also got the profile information for all these friends and followers. Finally, we had 17,013,356 unique tweets with 5,682,627 distinct YouTube video IDs, 19,004,341 friends and 22,182,881 followers for the 87,076 users. From this data we extracted a number of features related to (i) demographics, (ii) location, (iii) interests, and (iv) behavior on Twitter. Demographics. We used a name dictionary to infer the self-declared gender of a Twitter user using com- mon first names and gender from http://www.ssa.gov/oact/babynames/limits.html. To detect a subset of potential parents, we scanned each user's "bio" for mother/mom/wife or fa- ther/dad/husband using exact token match. Similarly, we identified a subset of potential students by scanning the bios for student/study/studying. Location. Each of the users profile locations was run through Yahoo!'s Placemaker geo-coder, http:// developer.yahoo.com/yql/console/, and for 61,250 profiles, a location could be identified. For the 23,416 users with an identified location in the US we checked if their city matched a list of the 100 biggest US cities from http://www.city-data.com/top1.html. This gave us an estimate of users from rural vs. urban areas. Interests. To detect interests of users, we chose to analyze the users they follow. These friends were then compared against directory information from http://wefollow.com1. Concretely, we obtained 1WeFollow is a website listing Twitter users for different topics along with a "prominence score", indicating importance of the user in the respective field. WeFollow's directory has been used in several academic studies [25, 5, 1, 27] 5/25 Adiya Abisheva, Venkata Rama Kiran Garimella, David Garcia, Ingmar Weber: Who Watches (and Shares) What on YouTube? And When? Using Twitter to Understand YouTube Viewership In Proceedings of the 7th International ACM Conference on Web Science and Data Mining 2014 information for the classes Sports, Movies, News & Politics, Finance, Comedy, Science, Non-profits, Film, Sci-Fi/Fantasy, Gaming, People, Travel, Autos, Music, Entertainment, Education, Howto, Pets, and Shows as described in Table 1. In addition to the information from wefollow.com, we labeled 32 politicians or party accounts on Twitter as either Democrats (13) or Republicans (19). The same list was also used by Weber, et al. [35, 37]. Users were then labeled as left or right according to the distribution of users they followed (if any). Following had previously been shown to be a strong signal for political orientation [7, 4, 35, 37]. Behavior. To quantify the activity of a user on Twitter, we extracted various features such as their number of tweets, the fraction of tweets that are retweets, or the fraction of tweets containing URLs. Finally, we also aggregated features from all YouTube videos shared by a user into statistics such as the average view count or the median inter-event time ("lag") between video upload and sharing. These features are described in more detail in the next section. Category Sports Movies News & Politics Finance Comedy wefollow.com Interests sports, baseb., basketb., soccer, footb., cricket, nfl movies economics, politics, news banking, investing, finance, entrepreneur, business comedy, comedian Science & Technology Non-profits & Activism tech, technology, gadgets, science, socialmedia non-profits, non-profit, charity, philanthropy Film & Animation Sci-Fi/Fantasy Gaming People & Blogs Travel & Events Autos & Vehicles Music Entertainment Education Howto & Style Pets & Animals Shows film, animation, cartoons scifi, sciencefiction, fantasy games, gaming blogger, blogs, people, celebrity travel, places automotive, autos, cars, vehicles music, dance, dancer entertainment academic, university, education howto, diy, doityourself animals, cats, dogs, pets tv, tvshows, media Table 1: Mapping of YouTube categories (left) to wefollow.com interests (right). The YouTube category "Trailers" was not mapped. The non-YouTube category "Finance" was added. 6/25 Adiya Abisheva, Venkata Rama Kiran Garimella, David Garcia, Ingmar Weber: Who Watches (and Shares) What on YouTube? And When? Using Twitter to Understand YouTube Viewership In Proceedings of the 7th International ACM Conference on Web Science and Data Mining 2014 3.2 YouTube Activity on Twitter Given 17,013,356 unique tweets with YouTube video IDs, we retrieved 15,211,132 sharing events and identified 6,433,570 unique YouTube video IDs. We define sharing event as a tweet containing valid YouTube video ID (having category, Freebase topics and timestamp), thus a tweet with two video IDs is considered as two sharing events. A fraction of videos in initial 17 million tweets were not valid, thus such tweets and consequently derived sharing events were removed. Using the YouTube API, the following data about videos was crawled within the period 7/7/2013 – 1/8/2013: title, uploader username, number of views, number of times video has been marked as favorite, number of raters, number of likes and dislikes, number of comments, video uploaded time and categories to which videos belong. Using the Freebase API we also crawled video topics which serve as deprecated video tags and are helpful for searching content on YouTube, e.g., "hobby", "music", "book" and many others are examples of Freebase topics (http://www.freebase.com/). The cleansing stage of data contained three parts: identify noise in data, introduce a filter on Twitter users with "extreme" behaviour and introduce a filter on "legacy" YouTube videos (see Section 5). In our data set, noisy data (0.53%) are those sharing events where the tweet's timestamp is earlier than the video's upload timestamp. Such negative lags spanned from 1 second up to a couple of years. We removed all such sharing events which seemed to occur 1) due to updated timestamp of streamed live videos recorded by YouTube where the time at the end of streaming is returned as published timestamp by YouTube API, and 2) due to altered timestamp of reuploaded videos by some YouTube "privileged" accounts. After removing noise, the data reduced to 15,130,439 sharing events, 5,669,907 unique video IDs and 87,069 user IDs. Handling the data, we came across "non-human" behaviour explained by automated video sharing. We identify Twitter accounts and YouTube channels possibly owned by the same user, and label such Twit- ter users, as promotional since the primary content of such videos is advertisement. These accounts are often in top 1 percentile of Twitter users sorted by the number of YouTube videos shared. Examples of such Twitter-YouTube pairs with the number of shared videos in brackets are: spanish_life – aspan- ishlife (8,119) on real estate advertisement and RealHollywoodTr – bootcampmc (5,315) blogging on fitness and health, while the mean number of shares per user was found at 174 video shares. To re- move promotional users, we applied a filtering mechanism based on a) similarity between usernames in Twitter and YouTube using longest common substring (LCS), and/or b) amount of videos in Twit- ter account coming from one YouTube source; for details refer to supplementary material submitted in: http://arxiv.org/abs/1312.4511. We follow an aggressive approach when detecting promo- tional users; thus, there is a possibility of some regular users being labeled as promotional but not the other way round. As a result of filtering we split Twitter accounts into 71,920 regular non-promotional and 15,149 promotional accounts. 7/25 Adiya Abisheva, Venkata Rama Kiran Garimella, David Garcia, Ingmar Weber: Who Watches (and Shares) What on YouTube? And When? Using Twitter to Understand YouTube Viewership In Proceedings of the 7th International ACM Conference on Web Science and Data Mining 2014 4 Who Watches What? In this section, we present a first analysis of who (in terms of Twitter user features) watches and shares what (in terms of YouTube video features). Though we include here user features related to the inter- event time, early video sharers are analyzed in Section 5. 4.1 Cluster Analysis As a first picture of who watches and shares what we present a cluster analysis of 26,938 non- promotional, sufficiently active users who shared at least 10 YouTube videos and had at least 10 friends matched on Twitter through WeFollow (see Table 1). These users were clustered into eight groups ac- cording to the (normalized) distribution of YouTube categories of the videos they shared using an ag- glomerative hierarchical clustering algorithm with a cosine similarity metric [21]. Table 2 shows the results. We were interested to see which differences for Twitter features are induced when users are grouped solely according to YouTube categories. To describe the clusters found, Table 2 first lists the discrimina- tive YouTube features as output by the clustering algorithm. Below it lists the 5 most prominent terms from the Twitter bios of users in this group. These terms, which were not used to obtain the clustering, give fairly intuitive descriptions of the user groups. Finally, the table lists features whose average value differs statistically significantly (at 1%) between the cluster and all 27K users. These features are ranked by the absolute difference between global and within-cluster averages, divided by the standard deviation. Inspecting the clusters, certain observations can be made. First, the discriminating YouTube categories (first block of five lines) are largely aligned with Twitter categories that are over-represented in the corresponding cluster (The "T *" in the bottom block of five lines). This alignment we will investigate more in Section 4.3. Second, there are certain correlations between the demographics and the YouTube Cluster1 (2740) sports music entertainment people/blogs non-profit fan music sports life football T sports+ Y sports+ Cluster2 (2327) animals music entertainment people/blogs sports music life fan lover writer Y animals+ T animals+ g n i t a n i m i r c s i D s e r u t a e f e l fi o r p s d r o w p o T - a e f p o T s e r u t Cluster3 (2493) non-profit music sports entertainment education music life fan world lover Y non-profit+ T non-profit+ num. usrs rtwd+ Cluster4 (5390) music non-profit sports education animals music life artist producer live Y music+ median lag+ T music+ mean lag+ Y education− Cluster5 (2535) Cluster6 (4052) news/politics film/animation music comedy entertainment education music life world conservative people Y news/politics+ Y comedy+ T news/politics+ education music non-profit sports music life fan lover time Y film+ Y education+ frac. Tw other URLs− frac. Tw other URLs+ leaning republic+ T movies+ Tfilm+ Cluster7 (3697) entertainment people/blogs howto sports music life music fan live justin Y howto+ Y people+ Y entertainment+ female+ Cluster8 (3704) travel music gaming science/tech autos music gamer life fan youtube Y gaming+ Y science/tech+ T gaming+ Y shows+ avg rtwt count user+ num. vids shared+ male+ std dev. of lag+ frac. Tw other URLs+ acnt created at− frac. of usrs Tw rtwd+ avg. frnds of frnds− frac. Tw Y videos− T education+ Table 2: Clusters obtained by clustering normalized YouTube categories distributions for each user. 8/25 Adiya Abisheva, Venkata Rama Kiran Garimella, David Garcia, Ingmar Weber: Who Watches (and Shares) What on YouTube? And When? Using Twitter to Understand YouTube Viewership In Proceedings of the 7th International ACM Conference on Web Science and Data Mining 2014 categories. For example, Cluster 1 is focused on sports and has more male users, whereas Cluster 7 is centered around entertainment and people/blogs and has more female users. Recall that the clustering was done according to YouTube categories, whereas the demographic information comes from Twitter, indicating the possible benefits of the combination. Finally, the clustering also picks up a connection to political orientation. Concretely, Cluster 5 contains more conservative users with an increased interest in news and politics (more on this in Section 4.3). 4.2 Demographics To understand the significance of the influence of variables such as gender or occupation on (i) the number of views, (ii) the polarization or controversiality2, and (iii) the lag we applied a so-called "per- mutation test" [17], which unlike other tests does not make assumptions on the distribution type of the observed variables. To test, say, the impact of stating "student" in the Twitter bio on the number of views we first computed the average view count for all views by the "student" group and compared this with the average for the complement "non-student" group. Let δ be the observed difference. Then to test the significance of δ we pooled all the student and non-student labeled observations and randomly permuted the two labels to get two groups. For these two groups, obtained by a label permutation, a δp was then computed. This process was repeated 10,000 times to estimate the common level of variability in the δp. We then marked the δ as significant if it was in the bottom/top 0.5% (or 2.5%) of the percentiles of the δp. In Table 3, a ∗∗ indicates that δ was in the bottom/top 0.5% and ∗ indicates that it was in the bottom/top 2.5%. For Table 4 we used a similar procedure to test the statistical significance of the Spearman rank correla- tion coefficient. Here, to establish the common level of variability we randomly permuted both rankings to be correlated 10,000 times and observed the distribution of the Spearman rank correlation coefficients. If the original, actual coefficient fell within the bottom/top 0.5%/2.5% we marked it as significant. Table 3 shows correlations with respect to the per-user median (i) number of views of shared videos, (ii) polarization/controversiality of shared videos and (iii) of inter-event times. One of the demographic differences that can be spotted is that men compared to women share less popular (fewer views) videos earlier (smaller lag). Some differences are hidden in this analysis though, as both urban and rural users seem to have a lower lag (share fast). The explanation for this apparent paradox is that users who have either no self-declared location or where the location is outside of the US have a comparatively larger lag, and that the comparison is with non-urban and non-rural, which mostly consist of these users, see Section 5.1 for more details. 2We calculate the polarization that a YouTube video creates on its viewers through its amounts of likes Lv, dislikes Dv, and total views Vv, through the equation P olv = Lv . The rationale behind this calculation is the rescaling of the likes and dislikes ratio based on the fact that they do not grow linearly with each other. The exponents correspond to the base rates of the logarithmically transformed amounts of views, likes and dislikes. This way we standardize the ratio over their nonlinear relation. · Dv V 0.884 V 0.849 v v 9/25 Adiya Abisheva, Venkata Rama Kiran Garimella, David Garcia, Ingmar Weber: Who Watches (and Shares) What on YouTube? And When? Using Twitter to Understand YouTube Viewership In Proceedings of the 7th International ACM Conference on Web Science and Data Mining 2014 male 0 0 −∗∗ fe- male +∗∗ −∗ +∗ urban rural −∗ 0 −∗ 0 −∗ −∗ views polariz. lag fa- US ther stu- mo- ther dent −∗ −∗ −∗ −∗ −∗∗ 0 +∗∗ −∗ −∗ 0 −∗ 0 Table 3: Demographics. A + indicates a positive deviation from the general population, - negative and 0 not statistically significant. ∗∗ indicates that the significance was based on δ being in the bottom/top 0.5%, ∗ for the bottom/top 2.5%. 4.3 Correlation Analysis In this section we analyze the relationship between Twitter user features, such as the number of followers or the fraction of tweets that contain a hashtag, and YouTube features, such as the number of views. As a simple analysis tool we computed Spearman's rank correlation coefficient for each pair of features. To simplify the presentation, we group the Twitter features into four classes. First, to see how "social" a user is we look at (i) the number of friends, and (ii) the number of distinct users mentioned. Second, to see how common "sharing" is for a user we included the fraction of tweets that (i) are retweets, (ii) contain a hashtag, (iii) contain a YouTube URL, and (iv) contain a non-YouTube URL. Finally, we look at notions of "influence" that includes (i) the number of Twitter followers, (ii) the fraction of a user's tweets that are retweeted, (iii) the average retweet count of tweets that obtained at least one retweet, and (iv) the average number of followers of a user's followers. For YouTube we consider the medians of (i) the number of views of videos shared by a user, (ii) the polarization of these videos, and (iii) the time lag of the video sharing events of the user. The number of comments received by videos shared by a user behaved qualitatively identical to the number of views and is omitted. Our results are presented in Table 4. Each cell in the table links a Twitter user feature group (row) with a particular YouTube video feature (columns). The three symbols in the cell indicate "+" = significant (at 1% using a permutation test as previously described) and positive, "-" = significant and negative, and "0" = not significant or below 0.05. The symbols are in the order of the features listed above in the text. Certain general observations can be made. For example, all of our notions of "social" correlate with a drop in lag time, and out of the topics considered, News & Politics is the one that is most consistently linked with users who actively share. But other observations are more complex and, for example, only some but not other notions of influence correlate positively with a large number of views. We also looked at relation between the Twitter user features and the fraction of video shares for various YouTube categories. Table 4 shows results for the three example categories Music, Sports and News & 10/25 Adiya Abisheva, Venkata Rama Kiran Garimella, David Garcia, Ingmar Weber: Who Watches (and Shares) What on YouTube? And When? Using Twitter to Understand YouTube Viewership In Proceedings of the 7th International ACM Conference on Web Science and Data Mining 2014 views polariz. Social Sharing Influence - - 0 - - - - - + 0 - - 0 - 0 - - - + 0 Music lag + 0 - - - - - - 0 - 0 - 0 - - + + 0 + 0 Sports 0 + News + + 0 + + 0 + + + + 0 0 + 0 + + - + Table 4: Columns 1-3 show the relation between Twitter and per-user aggregated YouTube features. Columns 4-6 show the relation between Twitter and fractions of categories of YouTube videos shared for three example categories. Twitter features are grouped into three classes. Symbols indicate strength and direction of significance. Bold symbols indicate an absolute value of Spearman's Rank correlation coefficient > 0.1. See text for details. Politics. Again, different patterns for different definitions of "influence" can be observed. Out of the three topics, News & Politics is the one that correlates most with social and with sharing behavior. 4.4 Interests on Twitter vs. YouTube Given that our analysis links Twitter behavior to YouTube sharing events it is interesting to understand if the interests on the two platforms are aligned. Though we cannot reason about YouTube views not cor- responding to Twitter sharing events, we compared the topical categories of a user's shared videos with the topical categories of their Twitter friends. To infer the latter, we used the WeFollow data described in Section 3.1 where entries in WeFollow were also weighted according to their prominence score. This way, a user following @espn (prominence 99) is given a higher weight for sports than a user follow- ing @hoyarowing (prominence 23). To compare if a user's YouTube category distribution and Twitter friends WeFollow distributions are similar, we decided not to compare these directly due to the following expected bias. The coverage by WeFollow for the different categories is likely to differ. For a popular topic such as music, the coverage is potentially over-proportionally good compared to less popular ones. To correct for this, we first normalize as follows. ij the prominence-weighted fraction of a user i's Twitter friends that are recognized in the WeFollow Let cT ij for their shared YouTube category distribution. Now normalize both of category j. Similarly, define cY kj. This, effectively, compares users these matrices for a fixed category j such that cT according to their relative interest in a given topic. This is then further normalized to obtain per-user probability distributions via cT ij across users i. Categories Then, for each category j, we look at the distribution of the differences cT where this difference is positive indicate a relatively higher importance/preference for Twitter, cases with a negative preference indicate a relatively higher importance for YouTube. Generally, the differences were very small with the median difference not exceeding .04 in absolute value for any category and being smaller than .01 for more than half. Some categories such as Film & Animation were very slightly more prominent on YouTube (indicated by the negative mean and median), whereas Science & Tech was ik, similarly for cY ij. ij/(cid:80) ij/(cid:80) ij− cY ij = cT k cT ij = cT k cT 11/25 Adiya Abisheva, Venkata Rama Kiran Garimella, David Garcia, Ingmar Weber: Who Watches (and Shares) What on YouTube? And When? Using Twitter to Understand YouTube Viewership In Proceedings of the 7th International ACM Conference on Web Science and Data Mining 2014 slightly more prominent on Twitter. This analysis was done for active users with at least 10 shared videos and at least 10 friends matched on WeFollow. 4.5 Politics in Twitter and YouTube To see how Politics is introduced in both Twitter and YouTube, we had the following questions in mind: a) which political user groups share more politically charged content, b) what is the most frequent content of each political user group. As mentioned in Section 3.1, to separate users into political groups we followed a US bipartite system with audience divided into left (L) and right (R) users. Users that followed more of the 13 left seed users were marked as left-leaning, users that followed more of the 19 right seed users were marked as right- leaning and users with a split preference or not following any seed user were marked as apolitical. Our approach resulted in three disjoint sets of left users UL (UL = 11, 217), right UR (UR = 1, 046) and apolitical users UA (UA = 57, 672). We addressed question a) by looking at how much L, R, A users share videos in the category News & Politics. If left-leaning user uL shared set of videos VL with a subset of videos in the category News & ∈ VL; then we looked at the distribution of ratio of number of political video shares Politics, V News&Politics to total amount of shares per each uL, uR and uA: r{uL,uR,uA} = . On average mean ratio of videos with political content for each user population is: µL = 0.06, µR = 0.29, µA = 0.05, which confirms right users share more news and politics related videos compared to left users and apolitical users. V News&Politics {L,R,A} V{L,R,A} L (cid:80) To answer question b) we calculated topic distributions of videos per each political user category and rank topics in each user group according to their frequency. In order to statistically compare the ranking of topics across groups, we applied the distance between ranks of topics method by Havlin [18]. If R1(λ) is the rank of topic λ in user group 1 and R2(λ) is the rank of the same topic λ in user group 2, distance r12(λ) between the ranks of topic λ in two user groups is r12(λ) = R1(λ) − R2(λ). Thus, the distance between two user groups is defined as the mean square root distance between the ranks of all 2 , where N is the number of common topics across user groups. common topics: r12 = ( 1 N We summarize the distance metric across four user groups: Left, Right, Apolitical and all population (Left, Right and Apolitical) with N = 23, 844 and Rmax = 281, 265 in Table 5. We find that the distances from right users is maximum to left, apolitical and all, and left and apolitical are close to each other in terms of distance. This suggests that right users have their own hierarchy of topics distinguished from left and apolitical users, while latter groups have more similar topics. To support our findings in distance between topic ranks, we look at the most 20 frequent Freebase topics for each user group. Right users share more politically charged content including politicians (Barack Obama, Alex Jones, Ron Paul), news channels (Russia Today, The Young Turks), military-related keywords (Gun, 12(λ)) λ r2 1 12/25 Adiya Abisheva, Venkata Rama Kiran Garimella, David Garcia, Ingmar Weber: Who Watches (and Shares) What on YouTube? And When? Using Twitter to Understand YouTube Viewership In Proceedings of the 7th International ACM Conference on Web Science and Data Mining 2014 Left Right Apolitical All Left - 35733.87 33807.2 25722.16 Right 35733.87 - 49314.69 37913.44 Apolitical 33807.2 49314.69 - All 25722.16 37913.44 23879.92 23879.92 - Table 5: Distance across political, apolitical and all user groups. Police) and concepts (USA). Conversely, left-leaning users have similar interests as apolitical, giving priority to entertainment videos. For example, "Barack Obama" topic (Freebase ID /m/02mjmr) is placed 30th popular among left users and 1st among right population. Results of a) and b) support each other and give the following picture on political engagement of L/R/A user groups. For left users, a) says they act as apolitical users and on average do not share much political videos, with b) confirming that among top 20 video topics of left users none relate to politics. And for right users, a) states that they share more political content which is supported by b) where 9 out of top 20 topics have government, news, politics related concepts. A possible explanation of the fact that the supposed left is much closer to the apolitical set than the right is that following @barackobama is not a good proxy for political orientation due to his popularity in so- cial media. To show that following @barackobama is a signal for both a) being more politicized and b) being more left-leaning we perform a number of statistical tests on differences between @barackobama followers and non-followers. For a) we count the number of known political hashtags such as #p2, #tcot, #obama, #ows and others for both user groups. For b) we count the number of words "liberal", "progres- sive", "democrat" and "conservative", "republican" in the bios of both followers and non-followers. The idea here is that the first (abbrev. L-words) and second (abbrev. R-words) word groups are indicators of someone being left- and right- aligned respectively. Table 6 shows results with a clear message: fol- lowers of @barackobama are at least 4 times more likely to be left-aligned compared to non-followers (0.70% vs. 0.16%) and are twice more likely to insert political hashtags in their tweets compared to non- followers (20.5% vs. 10.3%) . Ratios were tested with a Chi-square test for equality of proportions with a 95% confidence interval with significance at p-value < 10−15. followers ¬followers Political # 20.5% (3829) 10.3% (8615) L-words 0.70% (130) 0.16% (131) R-words 0.28% (53) 0.35% (281) Total 18664 83789 Table 6: Percentage and counts in brackets of users having political tweet hashtags, "left"- and "right"- words in account description of @barackobama followers and non-followers. 13/25 Adiya Abisheva, Venkata Rama Kiran Garimella, David Garcia, Ingmar Weber: Who Watches (and Shares) What on YouTube? And When? Using Twitter to Understand YouTube Viewership In Proceedings of the 7th International ACM Conference on Web Science and Data Mining 2014 5 Early Video Adopter . u This section answers a) who shares video content faster and b) which information is shared faster. Thus, we look at another dimension linking Twitter and YouTube – the time lag between the video upload and the sharing event on Twitter, also known as inter-event time or lag and denoted as ∆t. We perform inter- event time analysis on a system level and per user. For system inter-event time analysis we collected v , per sharing event (tweet w, video v), resulting in time lag collection T , i.e., ∀w ∈ time lags, ∆tw TWEETS,∀v ∈ VIDEOS, ∆tw v ∈ T , where TWEETS is a set of all tweets in data set and VIDEOS is a set of all videos. Thus, a user having more than one tweet with video has more than one time lag; similarly, a video that has been shared more than once will have more than one time lag; thus, several sharing events of a video are considered as separate sharing events, and time lag of each such event becomes a member of collection T . For per user inter-event time analysis we calculated median time lag per each user u, (cid:104)∆t(cid:105)median One limitation of the YouTube dataset was a non-uniform distribution of video age. Thus, we removed videos before certain epochs when YouTube and Twitter underwent changes. First, Twitter was founded in 2006, nearly one year after YouTube, thus we cannot sensibly study sharing of videos uploaded in 2005-2006. The next disrupting event is the introduction of Twitter share button in YouTube on 12/8/2010, changing the ease of sharing. Additionally, our crawled dataset had another constraint: a limit of 3,200 tweets per user which mainly has effect on tweets sample of active Twitter users. Selected sample potentially contains only recent tweets and thus relatively "young" videos in those tweets. In order to get a uniform age of shared videos, we determined a cutoff time for discarding videos of certain age at which amount of shares per user is affected the least. We removed videos older than θ = 1/1/2012, which automatically discards tweets containing such videos. The filtered data set contained 11,697,550 sharing events for 2,510,653 distinct videos coming from 70,874 non-promotional users. 5.1 Who Shares Faster in Twitter Question a) was addressed by comparing inter-event times per different user groups. We first looked at time differences between promotional and non-promotional Twitter accounts, see Figure 1 from a sys- tem's point of view (rather than aggregating per-user). Visually, we observe that promotional accounts are faster at sharing content compared to regular users, see the head at P (∆t) and tail at F (∆t). Sta- tistically, median(promo)= 104.8sec (18 hours), median(non-promo) = 105.1sec (38 hours). Within an hour promotional accounts have twice amount of shares compared to non-promotional accounts which constitutes twentieth and tenth percentile respectively. Having confirmed that there is a difference between human and "machine" behaviour, we performed a per-user inter-event time analysis for different user groups of non-promotional accounts. For each user (cid:105)median group UG we calculate the median lag per group (median of users' medians): ∆tG = (cid:104)(cid:104)∆t(cid:105)median . u∈UG u 14/25 Adiya Abisheva, Venkata Rama Kiran Garimella, David Garcia, Ingmar Weber: Who Watches (and Shares) What on YouTube? And When? Using Twitter to Understand YouTube Viewership In Proceedings of the 7th International ACM Conference on Web Science and Data Mining 2014 Figure 1: Inter-event time distribution P (∆t) and accumulative time distribution F (∆t)s of promo- tional (red) and non-promotional (blue) accounts. For example, in Section 4.5 we looked at who shares what per political user groups (Left vs. Right). Here we find that on average right users share newly uploaded video content at least 3 days earlier compared to left users. Note that the set of videos being shared is different though. Our findings on the median of the median inter-event times for various user groups are presented in Table 7. Time differences in the per topic medians follow the same trend as the overall distribution (not presented here), so the observed differences cannot solely be explained by differences in category preferences for different user groups. We highlight the following observations on who shares faster: concerning location, urban users are around 14 hours faster than rural users, and across gender women are much slower compared to men. Globally, people from Indonesia and Thailand have a reaction time in the order of a day, where as the greatest lag in the order of a half of a month is observed from people tweeting in Brazil. But as we selected only English profiles the results for other countries might be conflated with other factors. While doing our analysis we also observed that an important dimension of the "quickness" of the users relates to how often they share videos on Twitter. Figure 2 shows the median per-user median of the inter-event times for users divided into deciles according to the number of YouTube videos they have shared. The inter-event times are given in hours and range from 352 hours for the least active to 38 hours for the most active users. As the difference is quite striking, we inspected term clouds for the Twitter bios of the least active YouTube sharers and the most active YouTube sharers. Interestingly, the two are quite 15/25 PromotionalNot promotionalΔ t, secP(Δ t)10010110210310410510610710810-910-810-710-610-510-410-3PromotionalNot promotionalΔ t, secF(Δ t)10010110210310410510610710810-210-1100 Adiya Abisheva, Venkata Rama Kiran Garimella, David Garcia, Ingmar Weber: Who Watches (and Shares) What on YouTube? And When? Using Twitter to Understand YouTube Viewership In Proceedings of the 7th International ACM Conference on Web Science and Data Mining 2014 similar, apart from a prominent "YouTube" for the most active users, indicating that the difference in lag time is related to the activity level, not topical interests. 5.2 What is Shared Faster in Twitter To answer question b) we performed system inter-event time analysis and distributed time lags in T into relevant video category. If TC is a collection of system lags of set of videos belonging to category v ∈ TC, if v ∈ VIDEOSC. YouTube provides 19 video categories, in Figure 2 C (VIDEOSC), then ∆tw inter-event time of 6 categories which exhibit different patterns time distribution are shown, due to space limits. Remaining 13 video categories lag show similar patterns as Entertainment and Pets & Animals. Our findings show that among all videos, Gaming and News & Politics videos are the fastest shared with median time of 8 and 15 hours respectively, Movies and Trailers have the greatest lag between video uploaded and being tweeted with median of 5 and 3 months respectively. Category promotional non-promotional promotional urban promotional rural non-promotional urban non-promotional rural left right male female student not student mother not mother father not father Med. int. time num. users 27 141 40 25 143 157 163 90 142 187 156 141 191 141 85 141 15132 70874 2096 1693 5951 5928 11356 1355 24263 16293 877 69997 450 70424 356 70518 Table 7: Comparison of median of median inter-event times (in hours) for various groups of users 16/25 Adiya Abisheva, Venkata Rama Kiran Garimella, David Garcia, Ingmar Weber: Who Watches (and Shares) What on YouTube? And When? Using Twitter to Understand YouTube Viewership In Proceedings of the 7th International ACM Conference on Web Science and Data Mining 2014 Figure 2: Median of per-user median inter-event times for users bucketed (into deciles) by the number of YouTube videos shared (left). Accumulative time distribution F (∆t) of videos belonging to various YouTube categories (right). 6 Video Popularity Analysis 6.1 Forecasting Video Popularity In this section, we present our work on early indicators of the popularity of a video, i.e., its amount of views a sufficient amount of time after its creation. Our approach is based on analyzing the Twitter atten- tion to the video in the first moments after its creation, including the user profile information explained above. For this task, we filter our data following the cutoff date explained in Section 5, and restrict our analysis to videos that were created before June 1st 2013, a total of 4,822,675 videos created more than a month before the data retrieval date. We estimate the popularity of a video through the amount of views more than a month after its creation, following previous approaches by Szabo and Huberman [31], in line with the very fast decay of views that most videos have in YouTube as shown in Crane and Sornette [11]. For each video, we analyze its Twitter attention during the first week after its creation. We remove from our analysis all videos that, during this first week, did not have any sharing event in our data. This removes old videos that were created before Twitter grew to its actual user base, leaving us with a set of 276,488 videos. To analyze the role of user interests and promotions, we divide our analysis of Twitter data in two subsets: one only based on promotional users, and one based on non-promotional users. 17/25 24681050100150200250300350Bucket numberMedian of per-user median Δ t, hrsΔ t, secF(Δ t)Entertainment, med=1.345*105Gaming, med=2.99*104Movies, med=1.344*107News & Politics, med=5.519*104Pets & Animals, med=3.147*105Trailers, med=7.45*10610010110210310410510610710810-310-210-1100 Adiya Abisheva, Venkata Rama Kiran Garimella, David Garcia, Ingmar Weber: Who Watches (and Shares) What on YouTube? And When? Using Twitter to Understand YouTube Viewership In Proceedings of the 7th International ACM Conference on Web Science and Data Mining 2014 After such filtering, we have a total amount of 1,200,924 shares and 182,135 videos from promotional users, and 779,821 shares and 133,373 videos from non-promotional users. Note that these two datasets are disjoint in terms of Twitter data. No Twitter share is taken into account in both, but they overlap in 17,093 videos. 6.2 Twitter Video Metrics We measure the early Twitter attention towards a video aggregating two types of data: i) amount of tweets or attention volume, and ii) reputation metrics calculated from the follower network and retweet- ing behavior of the users involved. For each video, we computed five metrics of Twitter attention that summarize different factors that potentially increase video popularity: We measure the total attention in Twitter to a video through the amount of shares Sv during the first week, which were produced by the set of users that shared the video in the first week, noted as Uv ∈ U. Each user u created nv(u) shares of the video, which were received by the set of followers of those users. We define the exposure Ev of a video as the sum of followers of the users that shared the video in the first week, where F (u) is the set of followers of user u, and f (u) = F (u). This measure approximates the size of the first order neighborhood of the accounts sharing the video, overcounting their common friends. We aggregate the social impact Iv of the users that shared the video estimated as their mean amount of retweets for tweets with nonzero retweets (R0(u)). To improve estimation of the reputation of the users sharing the video in the first week, we approximate the size of the second-order neighborhood of the users that shared the video. For this, we calculate the second-order exposure Ev, as the sum of the amount of followers of the followers of the users that shared the video. Each user exposed to the shares of the video is subject to have its attention diluted over a set of different information sources. For this reason, we calculate the share of voice Av of the early users, as the ratio of their amount of followers divided by the average amount of users followed by their followers, where f−1(v) is the amount of users that v follows. This way, we correct the case of users with many followers, who would give a lower share of voice if they follow a large amount of other users. On the other hand, Amount of shares nv(u) Sv = (cid:80) Ev = (cid:80) u∈Uv (cid:80) Exposure Ev = (cid:80) f (u(cid:48)) Av = (cid:80) u∈Uv Second-order exposure f (u) u∈Uv u(cid:48)∈F (u) u∈Uv Social impact Iv = (cid:80) u∈Uv R0(u) Share of voice f (u)/(cid:104)f−1(u(cid:48))(cid:105)u(cid:48)∈F (u) Table 8: Twitter social metrics used related to video popularity. 18/25 Adiya Abisheva, Venkata Rama Kiran Garimella, David Garcia, Ingmar Weber: Who Watches (and Shares) What on YouTube? And When? Using Twitter to Understand YouTube Viewership In Proceedings of the 7th International ACM Conference on Web Science and Data Mining 2014 a user with a low amount of followers can have a large share of voice, when its followers do not follow many other accounts. We use these five metrics to create a video vector with a sixth dimension being its final amount of views. In the following, we present our analysis of the relations between these five metrics and the popularity of a video. 6.3 Factors Influencing Video Popularity The distribution of views per video, as well as the other metrics explained above, have large variance and are skewed to the right. To avoid the uneven leverage of extreme values of these distributions, we have applied a logarithmic transformation to each one of them, reducing their variance but keeping their rank. In the first step of our analysis, we computed correlation coefficients between the logarithm of the amount of views and the other five variables. The results for promotional and non-promotional data are summarized in Table 9, revealing significant correlations for all of them. Some of this correlations are of very low magnitude or even negative sign, suggesting a more careful analysis. Our first observation is that the amount of shares in the first week of a video is a better predictor for its popularity in the case of non-promotional users and promotional ones (ρ = 0.184 vs ρ = 0.298). The left panel of Figure 3 shows the mean amount of views of videos binned exponentially by their amount of Twitter shares. The two types of user activities diverge after 20 shares in the first week, where for the case of non- promotional users the amount of views appears to be increasing but saturating. Regression on a power- law relation between views and shares V ∝ Sα reveals a superlinear scaling with α = 2.18 ± 0.02, i.e., the final views of a video has a quadratic relation to the amount of regular user shares in the first week. As an example of this superlinear growth, the mean amount of views for videos with 2 shares in the first week is 151,374.5, for videos with 7 shares is 644,522.4, and for videos with 12 shares is 2,349,317. This gives an increase of almost 500K views for the five shares after the first two, but an increase of more than 1.7M for the five shares after the first seven. The diverging pattern in both types of user activity reveals that, when promotional accounts share the same video more than 20 times in the same week, the final amount of views does not increase. In fact, Type Nonpr 0.3 Sv 0.3 0.1 Promo 0.18 0.19 0.16 Ev X Iv Ev Av 0.08 0.16 0.4 0.4 0.28 0.26 0.27 0.13 0.29 0.09 -0.05 -0.16 0.08 0.04 Table 9: Pearson's (first value) and Spearman's (second value) correlation coefficients between video views and Twitter measures: ρ(log(Vv), log(X)), all with p < 10−10 19/25 Adiya Abisheva, Venkata Rama Kiran Garimella, David Garcia, Ingmar Weber: Who Watches (and Shares) What on YouTube? And When? Using Twitter to Understand YouTube Viewership In Proceedings of the 7th International ACM Conference on Web Science and Data Mining 2014 Figure 3: Mean amount of views videos binned by amount of shares (left) and social impact of early adopters (right). Error bars show standard error, and dashed lines regression results. there is a decreasing pattern of views, suggesting the existence of information overload or spamming behavior in promotional users. For both types of Twitter users, the aggregated social impact in terms of mean retweet rates is the best predictor for the popularity of a video (ρ = 0.394 and ρ = 0.28). The right panel of Fig. 3 shows the mean view values for bins of the aggregated social impact, with the result of regression of the form V ∝ I β, where β = 0.576 ± 0.004 for non-promotional users and β = 0.358 ± 0.003 for promotional ones. This result reveals a sublinear relation between the amount of views and the social impact of the accounts that shared the video in the first week, close to a square root. The amount of views of videos showed a low positive correlation coefficient with the exposure of the shares in the first week, measured through amount of followers. The left panel of Fig. 4 shows the mean amount of views versus the exposure in the first week, revealing a very soft increasing pattern in both. On the other hand, the amount of views has a more substantial correlation with the second-order exposure, with correlation coefficients of 0.268 and 0.126 for regular and promotional users respectively. The right panel of Fig. 4 shows this stronger relation, with a regression result of exponent 0.404 ± 0.004 for non- promotional users, and of 0.155 ± 0.003 for promotional ones. This comparison reveals that the second- order exposure is a much better predictor for the popularity of a video than the amount of followers of the initial sharers. This result calls for more stylized reputation metrics that take into account global information beyond amount of followers and retweet rates, for example centrality [15], or coreness [13] metrics. 20/25 251020501002001e+031e+041e+051e+061e+07TwitterSharesYoutubeViewsuseraccountspromotionalaccountsV∝S2.1411021e+001e+021e+041e+061e+031e+041e+051e+061e+07Social Impact [retweets]YoutubeViewsuseraccountspromotionalaccountsV∝I0.5760413 Adiya Abisheva, Venkata Rama Kiran Garimella, David Garcia, Ingmar Weber: Who Watches (and Shares) What on YouTube? And When? Using Twitter to Understand YouTube Viewership In Proceedings of the 7th International ACM Conference on Web Science and Data Mining 2014 Figure 4: Mean amount of views videos binned by first and second order exposure. Error bars show standard error, and dashed lines regression results. Finally, the aggregated share of voice of the accounts that shared the video during the first week did not provide clear results, with a significant negative correlation of −0.047 for non-promotional users, and of 0.076 for promotional ones. This suggest that, if information overload and competition for attention are present in Twitter, they need to be measured with more precise approximations that the correction we presented in the previous section. Nevertheless, the share of voice of the users sharing a video still contains relevant information that we introduce in the regression model we explain below. 6.4 Combining Data in a Regression Model The above results show the pairwise relation between the amount of views of a video and each one of our five Twitter metrics. This analysis ignores the possible effect of the combination of different metrics, as it can be expected that they are correlated with each other. To provide a deeper analysis on how these Twitter metrics influence the final amount of views, we propose a substitutes model in which the products of powers of each variable are proportional to the final amount of views: Vv ∝ ·Sα v · I β v · Eγ v · E δ v · Aκ v (1) This model is equivalent to a linear regression model after the logarithmic transformation of all the independent variables. Training this regressor on the promotional user data gives R2 = 0.107, explaining about 10% of the variance of log(V ). On the non-promotional user dataset, the regressor achieves R2 = 0.199, explaining almost 20% of the variance of the final amount of views of a video based exclusively on 21/25 1e+001e+021e+041e+061e+081e+035e+035e+045e+055e+06Exposure [followers]YoutubeViewsuseraccountspromotionalaccountsV∝E0.1898191e+021e+051e+081e+111e+141e+021e+041e+06Second-order Exposure [FoF]YoutubeViewsuseraccountspromotionalaccountsV∝0.403603E Adiya Abisheva, Venkata Rama Kiran Garimella, David Garcia, Ingmar Weber: Who Watches (and Shares) What on YouTube? And When? Using Twitter to Understand YouTube Viewership In Proceedings of the 7th International ACM Conference on Web Science and Data Mining 2014 Type Not promo Promotional Sv 1.083∗ 0.612∗ Ev 0.096 0.164∗ Iv 0.449∗ 0.307∗ Av Ev 0.118∗ −0.102∗ 0.079∗ 0.030 Table 10: Regression coefficients for Eq. 1. Significance level ∗ p < 10−9, or p > 0.01 otherwise. information extracted from Twitter. This opens the possibility to improve previous models that used only data from YouTube [31, 28], which could also be combined with data from other online communities, as previously done in Soysa et al. [30] with a limited sample of Facebook data. The estimated coefficients for the exponents of Eq. 1 are reported in Table 10, which allow us to compare the size of the effects of each Twitter metric. This analysis reveals the lack of relevance of the first-order exposure for the case of non-promotional users as also shown in Cha et al. [6]. The correlation between first order exposure and views shown in Fig. 4 is a confound due to the correlation of exposure with other metrics, such as impact or second-order exposure. To assess the prediction power of our model for non-promotional users, we transformed the regression problem to a dichotomous classification, in which we tag a video as popular if it gathered at least 10,000 views. Using the regression model explained above, we can predict if a video will reach more than 10,000 views based on the first week of Twitter activity. If the estimator of Eq. 1 gives a value above 10,000, we classify the video as popular. We performed 10-fold cross validation on the non-promotional users dataset, fitting the regressor to 90% of the data and validating it on the rest 10%. The mean base rate of popular videos for the 10 evaluations is 0.493, and our predictor achieves a mean precision of 0.715 and a mean recall of 0.534 for the popular class. Both values are significantly above the precision of random classifiers over the same partitions, which produced a precision of 0.492 and a recall of 0.494. This experiment shows that, using Twitter data only, a prediction can achieve a precision value much higher than expected from a random classifier. 7 Conclusions We gathered a high-quality dataset based on the combination of two sources: 17 million unique public tweets for 87K users on Twitter and YouTube data for 5 million videos. Through this combination of data sets, we could obtain novel, detailed insights into who watches (and shares) what on YouTube, and when (that is, how quickly). We applied a set of heuristics to infer demographic data including gen- der, location, political alignment, and interests. We designed a new method to distinguish promotional Twitter accounts, who almost exclusively share their own YouTube videos and validated our expectation that promotional users share their own videos much faster than regular ones. Our results also include a new method to characterize different user segments in terms of YouTube categories, Twitter activity, and 22/25 Adiya Abisheva, Venkata Rama Kiran Garimella, David Garcia, Ingmar Weber: Who Watches (and Shares) What on YouTube? And When? Using Twitter to Understand YouTube Viewership In Proceedings of the 7th International ACM Conference on Web Science and Data Mining 2014 Twitter user bios. These allowed us to analyze the relation between demographic factors and the features of YouTube videos, including their amount of views. Our detailed statistical analysis reveals correlations between Twitter behavior and YouTube video content. In addition, our clustering analysis shows that the topic preferences of the two platforms are largely aligned. Our results on politics quantitatively show that politically right users are further from the center than politically left users, and among all video categories News & Politics correlates most with social and with sharing behavior. Our detailed analy- sis distinguishes which user types share videos earlier/later as well as which video classes are shared earlier/later. Finally, we developed a regression model for the effect of early Twitter video shares by influential users on the final view count and we conclude by observing that second-order neighborhoods and retweet rates are much better predictors of ultimate video popularity than raw follower counts. 8 Acknowledgments ETH received funding from the Swiss National Science Foundation under the grant CR21I1_146499 / 1. The authors would like to thank GNIP for providing data during a free trial period of their Powertrack product. References [1] F. Al Zamal, W. Liu, and D. Ruths. Homophily and latent attribute inference: Inferring latent attributes of twitter users from neighbors. In ICWSM, 2012. [2] S. Asur, B. A. Huberman, G. Szabo, and C. Wang. Trends in Social Media: Persistence and Decay. In ICWSM, pages 434–437, 2011. [3] A.-L. Barabasi. The origin of bursts and heavy tails in human dynamics. Nature, 435:207, 2005. [4] P. Barbera. Birds of the Same Feather Tweet Together. Bayesian Ideal Point Estimation Using Twitter Data, 2012. Forthcoming. [5] S. Bostandjiev, J. O'Donovan, and T. Höllerer. Tasteweights: A visual interactive hybrid recom- mender system. In RecSys, pages 35–42, 2012. [6] M. Cha, H. Haddadi, F. Benevenuto, and P. K. Gummadi. Measuring user influence in twitter: The million follower fallacy. In ICWSM, 2010. [7] M. Conover, J. Ratkiewicz, M. Francisco, B. Gonçalves, F. Menczer, and A. Flammini. Political polarization on twitter. In ICWSM, 2011. 23/25 Adiya Abisheva, Venkata Rama Kiran Garimella, David Garcia, Ingmar Weber: Who Watches (and Shares) What on YouTube? And When? Using Twitter to Understand YouTube Viewership In Proceedings of the 7th International ACM Conference on Web Science and Data Mining 2014 [8] M. D. Conover, B. Gonc, A. Flammini, and F. Menczer. Partisan Asymmetries in Online Political Activity. EPJ DataScience, 1(6):1–17, 2012. [9] M. D. Conover, B. Goncalves, J. Ratkiewicz, A. Flammini, and F. Menczer. Predicting the Political Alignment of Twitter Users. In PASSAT-SocialCom, pages 192–199, 2011. [10] R. Crane, F. Schweitzer, and D. Sornette. Power law signature of media exposure in human response waiting time distributions. Physical Review E, 81(5):056101, 2010. [11] R. Crane and D. Sornette. Robust dynamic classes revealed by measuring the response function of a social system. PNAS, 105(41):15649–15653, 2008. [12] F. Figueiredo, F. Benevenuto, and J. M. Almeida. The tube over time: Characterizing popularity growth of youtube videos. In WSDM, pages 745–754, 2011. [13] D. Garcia, P. Mavrodiev, and F. Schweitzer. Social resilience in online communities: The autopsy of friendster. 1st ACM Conference on Online Social Networks (Forthcoming), 2013. [14] D. Garcia, F. Mendez, U. Serdült, and F. Schweitzer. Political polarization and popularity in online participatory media. In PLEAD, pages 3–10, Nov. 2012. [15] D. Gayo-Avello. Nepotistic relationships in twitter and their impact on rank prestige algorithms. Inf. Process. Manage., 49(6):1250–1280, 2013. [16] S. Goel, J. M. Hofman, and M. I. Sirer. Who does what on the web: A large-scale study of browsing behavior. In ICWSM, 2012. [17] P. I. Good. Permutation, Parametric, and Bootstrap Tests of Hypotheses. Springer, 3 edition, 2005. [18] S. Havlin. The distance between zipf plots. Physica A Statistical and Theoretical Physics, 216(1- 2):148–150, 1995. [19] S. R. Kairam, M. R. Morris, J. Teevan, D. J. Liebling, and S. T. Dumais. Towards supporting search over trending events with social media. In ICWSM, 2013. [20] M. Karsai, K. Kaski, A.-L. Barabási, and J. Kertész. Universal features of correlated bursty be- haviour, May 2012. [21] G. Karypis. Cluto: A clustering toolkit, 2002. http://www.cs.umn.edu/~cluto. [22] J. Kulshrestha, F. Kooti, A. Nikravesh, and P. K. Gummadi. Geographic dissection of the twitter network. In ICWSM, 2012. [23] M. S. S. Laine and G. Ercal. User Groups in Social Networks: An Experimental Study on YouTube. In 2011 44th Hawaii International Conference on System Sciences, pages 1–10, Jan. 2011. 24/25 Adiya Abisheva, Venkata Rama Kiran Garimella, David Garcia, Ingmar Weber: Who Watches (and Shares) What on YouTube? And When? Using Twitter to Understand YouTube Viewership In Proceedings of the 7th International ACM Conference on Web Science and Data Mining 2014 [24] J. Lehmann, B. Gonçalves, J. J. Ramasco, and C. Cattuto. Dynamical classes of collective attention in twitter. In WWW, page 251, New York, New York, USA, 2012. [25] Q. V. Liao, C. Wagner, P. Pirolli, and W.-T. Fu. Understanding experts' and novices' expertise judgment of twitter users. In CHI, pages 2461–2464, 2012. [26] A. Mislove, S. Lehmann, Y.-y. Ahn, J.-p. Onnela, and J. N. Rosenquist. Understanding the demo- graphics of twitter users. In ICWSM, pages 554–557, 2011. [27] M. Pennacchiotti and A.-M. Popescu. Democrats, republicans and starbucks afficionados: User classification in twitter. In KDD, pages 430–438, 2011. [28] H. Pinto, J. M. Almeida, and M. A. Gonçalves. Using early view patterns to predict the popularity of youtube videos. In WSDM, pages 365–374, 2013. [29] L. Qiu, Q. Tang, and A. B. Whinston. Two formulas for success in social media: Social learning and network effects, 2013. Forthcoming. [30] D. Soysa, D. Chen, O. Au, and A. Bermak. Predicting youtube content popularity via facebook data: A network spread model for optimizing multimedia delivery. In CIDM, pages 214–221, 2013. [31] G. Szabo and B. A. Huberman. Predicting the popularity of online content. Communications of the ACM, 53(8):80, 2010. [32] J. Teevan, D. Ramage, and M. R. Morris. #twittersearch: A comparison of microblog search and web search. In WSDM, pages 35–44, 2011. [33] A. Ulges, D. Borth, and M. Koch. Content analysis meets viewers: linking concept detection with demographics on youtube. IJMIR, 2(2):145–157, 2013. [34] C. Wang and B. A. Huberman. Long trend dynamics in social media. EPJ Data Science, page 8, May 2012. [35] I. Weber, V. R. K. Garimella, and E. Borra. Political search trends. In SIGIR, pages 1012–1012. ACM, 2012. [36] I. Weber, V. R. K. Garimella, and E. Borra. Inferring audience partisanship for youtube videos. In WWW, pages 43–44, 2013. [37] I. Weber, V. R. K. Garimella, and A. Teka. Political hashtag trends. In ECIR, pages 857–860, 2013. [38] I. Weber and A. Jaimes. Who uses web search for what: and how. In WSDM, pages 15–24, 2011. [39] Y. Wu, C. Zhou, J. Xiao, J. Kurths, and H. J. Schellnhuber. Evidence for a bimodal distribution in human communication. Proceedings of the National Academy of Sciences, 107(44):18803–18808, Oct. 2010. 25/25
1706.10172
1
1706
2017-06-30T12:27:11
Prepaid or Postpaid? That is the question. Novel Methods of Subscription Type Prediction in Mobile Phone Services
[ "cs.SI", "cs.LG", "physics.soc-ph", "stat.ML" ]
In this paper we investigate the behavioural differences between mobile phone customers with prepaid and postpaid subscriptions. Our study reveals that (a) postpaid customers are more active in terms of service usage and (b) there are strong structural correlations in the mobile phone call network as connections between customers of the same subscription type are much more frequent than those between customers of different subscription types. Based on these observations we provide methods to detect the subscription type of customers by using information about their personal call statistics, and also their egocentric networks simultaneously. The key of our first approach is to cast this classification problem as a problem of graph labelling, which can be solved by max-flow min-cut algorithms. Our experiments show that, by using both user attributes and relationships, the proposed graph labelling approach is able to achieve a classification accuracy of $\sim 87\%$, which outperforms by $\sim 7\%$ supervised learning methods using only user attributes. In our second problem we aim to infer the subscription type of customers of external operators. We propose via approximate methods to solve this problem by using node attributes, and a two-ways indirect inference method based on observed homophilic structural correlations. Our results have straightforward applications in behavioural prediction and personal marketing.
cs.SI
cs
Prepaid or Postpaid? That is the question. Novel Methods of Subscription Type Prediction in Mobile Phone Services Yongjun Liao, Wei Du, M´arton Karsai, Carlos Sarraute, Martin Minnoni and Eric Fleury Abstract In this paper we investigate the behavioural differences between mobile phone customers with prepaid and postpaid subscriptions. Our study reveals that (a) postpaid customers are more active in terms of service usage and (b) there are strong structural correlations in the mobile phone call network as connections between cus- tomers of the same subscription type are much more frequent than those between customers of different subscription types. Based on these observations we provide methods to detect the subscription type of customers by using information about their personal call statistics, and also their egocentric networks simultaneously. The key of our first approach is to cast this classification problem as a problem of graph labelling, which can be solved by max-flow min-cut algorithms. Our experiments show that, by using both user attributes and relationships, the proposed graph la- belling approach is able to achieve a classification accuracy of ∼ 87%, which out- performs by ∼ 7% supervised learning methods using only user attributes. In our second problem we aim to infer the subscription type of customers of external op- erators. We propose via approximate methods to solve this problem by using node attributes, and a two-ways indirect inference method based on observed homophilic structural correlations. Our results have straightforward applications in behavioural prediction and personal marketing. Yongjun Liao (e-mail: [email protected]), M´arton Karsai (e-mail: [email protected]), Eric Fleury (e-mail: [email protected]) Univ Lyon, ENS de Lyon, Inria, CNRS, UCB Lyon 1, LIP UMR 5668, IXXI, F-69342, Lyon, France. Wei Du (e-mail: [email protected]) Univ Lyon, INSA Lyon, Inria, CITI, F-69621 Villeurbanne, France. Carlos Sarraute (e-mail: [email protected]), Martin Minnoni, (e-mail: martin@ grandata.com) Grandata Labs, Bartolome Cruz 1818 V. Lopez. Buenos Aires, Argentina. 1 2 1 Introduction Authors Suppressed Due to Excessive Length In most of the countries mobile phone operators propose two subscription options for their customers. In case of prepaid subscription, credit is purchased in advance by the customer and access to the service is granted only if there is available credit. On the contrary, in case of postpaid subscription, a user is engaged in a long-term contract with the operator, and service is billed according to the usage at the end of each month. Typically, a contract specifies a limit or "allowance" of minutes and text messages for what a user is billed at a flat rate, while any further usage incurs extra charges. Due to these differences in the level and time of engagement, differ- ent options of subscriptions may be adopted by typical user groups characterised by similar age, location, socioeconomic status, etc., Moreover, due to effects of ho- mophily and social influence these people may be even connected to each other and communicate frequently thus forming a locally homogeneous sub-structures in the larger mobile communication network. Such correlations between the communica- tion dynamics, structure and customer features can potentially be used to differenti- ate between customers. In this paper, we are interested in such behavioural differences of prepaid and postpaid customers for at least three reasons. • The detection of typical patterns of service usage corresponding to different sub- scription types may provide useful information for the operator when planning network management and service pricing. • The identification of customers with atypical service usage patterns of their actual subscription type may help the design of better direct advertising and personal services. • The inference of the subscription type of customers of other operators could help direct marketing to convince customers to migrate to the actual provider. Our study based on the analysis of customers of a single operator reveals that the main difference between prepaid and postpaid users is in the way they use mobile phone services. As a first result we found that postpaid users are more active and on average make more calls, towards more people as compared to prepaid users. We also found that only relying on attributes of call statistics, such as total duration and number of outgoing calls, we can classify fairly well customers, with an overall accuracy of ∼ 80%, by using standard machine learning tools. However, to achieve better results, further we investigated the proxy social net- work of users mapped out from their mobile phone communication events. This analysis revealed strong structural correlations among users of the same subscrip- tion type, who actually called each other ∼ 3 times more frequently than others holding the opposite subscription type. This observation suggested that the classifi- cation accuracy could potentially be improved by algorithms considering not only individual activity patterns but also relationships between users at the same time. This is important, as, on the one hand, classification methods typically focus on find- ing distinct attributes associated to each class, while ignoring the network topology; and on the other hand, methods aiming to partition networks (e.g. tools of commu- Prepaid or Postpaid? That is the question 3 nity detection) typically ignore attributes associated to each node. By considering simultaneously the two sources of information, we propose an approach to com- bine classification and graph partitioning techniques in a unified framework To this end, we formulate the classification problem as a problem of graph labelling, i.e. as- signing a label, either prepaid or postpaid, to each user by taking into account both the user attributes and the structure in the mobile phone call network. This graph labelling problem can be solved by algorithms such as max-flow min-cut [14, 4], which in turn lead to an improved classification accuracy of 87%. Inspired by these results, we further addressed the practical problem of infer- ring the service type of customers of external operators from the view of the host provider. Such information is important for mobile service operators to expand busi- ness in the already crowded telecommunication market. In this settings we consider two sets of customers: one set includes customers of the host operator (company users) with the subscription type and all call records available. The other set includes customers of external operators (non-company users) with no information available but only about their interactions with company users. As mobile service operators never share the data of their customers for the concerns of economy, security and privacy, an operator can only perform this inference problem by using visible data such as the subscription types and the communication records of its own company users (including calls with non-company users) but without knowing anything about the communications between any two non-company users. However, by assuming that the same structural correlations exists between customers of different providers as observed between company users, we propose possible ways to infer and indi- rectly verify subscription types of non-company users, even without knowing their real values. This explanatory study below shows that our direct inference method, based on node attributes and structure extracted from call data between two oper- ators, alone can achieve an accuracy of ∼ 70%, while indirect inference methods may also provide meaningful insights. The rest of the paper is organised as follows. In Section 2 we discuss the related works, in Section 3 and 4 we describe the dataset in use and the classification re- sults using machine learning methods based merely on node attributes. Section 5 presents our graph labelling algorithm which exploits both node attributes and the local network structure. In Section 6 we introduce our methods of inference of the subscription types of non-company users. Finally in Section 7 we conclude our work and discuss some potential future directions of research. 2 Related Work Our work is motivated by the work of Yang et al. [18] in which network communities are identified by using both user attributes and the structure of the social network. However, one important distinction of the present work is that in [18] the authors aimed to cluster nodes with similar attributes into some apriori unknown number of communities, whereas we aim to find discriminating attributes of nodes and as- 4 Authors Suppressed Due to Excessive Length sign them to two pre-defined communities. In addition, our approach is based on graph labelling and solved by simple graph algorithms, whereas [18] is based on a generative model optimised by block-coordinate descent. Other related works on community detection with user attributes include [5, 15, 17]. However, all of them focus on clustering nodes in a network into priori unknown partitions or communi- ties, while none of them address the classification of nodes into pre-defined classes as here. A related classification problem which has been well studied in the litera- ture is the inference of user demographics such as nationality, gender and age from social and mobile call networks [8, 6, 12, 2, 19]. While interesting, most of the pre- vious work exploited only node attributes some of which are computed from local connections. Knowledge transfer from one network to another is also a hot topic in the field of machine learning and social network analysis. Most of these works focused on the inference of the structure, i.e. link prediction, using information from multi- ple networks. For example, Eagle et al. inferred the friendship network from mo- bile call data [9] and Dong et al. [7] and Ahmad et al. [1] predicted links across heterogeneous networks, which may only be partially visible. In addition, Tang et al. [16] studied the problems of relationship classification across networks and Kong et al. [11] inferred the anchor links between users in different social networks, i.e. the same user with different accounts. In contrast to most previous work, our study on cross-network inference focuses on the classification of nodes in the targeted network using only the connections between two networks. 3 Dataset Our dataset is a sequence of anonymised Call Detailed Records (CDR) collected by a single operator in a Latin American country. It contains ∼ 280 millions of call and SMS events recorded during one month between ∼ 20 millions of mobile phone users. Each CDR records the starting time of the event (date and time), communi- cation type (call or SMS), the call duration (in case of call event), the anonymised identifier of the user originating the call (caller), and the anonymised identifier of the person receiving the call (callee), but not the content of that transaction. Note that from the caller and callee at least one is a customer of the operator. For the first part of our study we constructed a dataset (DS1) of 3.2 million users, who are actual customers of the operator, and have available information about there subscription type being prepaid or postpaid. After filtering out users with either too few (total duration of calls < 10 seconds) or unrealistically many (total duration of calls > 100,000 seconds) communications, we obtained about 1.3 million pre- paid and 1.2 million postpaid users in total. For the purpose of our investigation, from the 190 million CDRs of 2.5 million selected users, we constructed a directed weighted communication network with 90 million links between interacting users. More precisely, the communication network G = (V,E) was define by mobile users as nodes connected by directed weighted links. Links (u,v,w) ∈ E between users u Prepaid or Postpaid? That is the question 5 and v (where u,v ∈ V ) were drawn if at least one communication event took place between them during the observation period. The weight w of a directed link was defined as the number of communication events or the total duration of calls took place between u and v (actual weight definition is specified later). Note that DS1 is balanced with roughly the same number of users for each type. However, our approach does not rely on this fact as the only assumption we take is based on a structural correlation in the communication network, which we will verify in the next sections. For the second part of our study we considered the whole available communi- cation sequence to construct a dataset (DS2). After similar filtering as before, we obtained 3.1 million company users (1.6 million prepaid and 1.5 million postpaid), with full list of CDRs available, and 14.1 million non-company users, with CDRs available only with company users. Note that the increase of company users in DS2 as compared to DS1 is due to the company users who only interacted with non- company users, thus appear only in DS2 with non-zero degree. In DS2 in total we had 190 million calls between company users and 90 million calls between com- pany and non-company users. Using these events we constructed a network, which contained 90 million links between company users (just as in DS1), and 44.6 million links between company and non-company users. 4 User Attributes and Classification For each user, using the first dataset DS1 we extracted a number of attributes related to call statistics including: • total number of outgoing calls; • total duration of outgoing calls; • mean and standard derivation of the duration of outgoing calls; • outgoing degree (number of callees) in the CDR network. These attributes turned out to be very different for prepaid and for postpaid users as shown in Figure 1 where the distributions of (a) the total number of outgoing calls, (b) the total and (c) the average duration of outgoing calls, and (d) the outgoing degrees are depicted. From these measures we found that on average postpaid users make 2.9 times more calls to 2.5 times more people as compared to prepaid users. Note that we tested and found that attributes related to incoming calls and SMS are not informative. By using these attributes, we built our classifiers with different ma- chine learning methods including support vector machines (SVM), Boosting (Ad- aBoost), Naive Bayes and Decision Tree to estimate the subscription type of each user. In every experiment presented in the paper, the classifiers were trained using 20,000 randomly sampled users, half of them prepaid and half postpaid, and tested on the rest of the 2.5 million users. After these experiments we found that SVM and AdaBoost achieved the best accuracy of about 80%, while Naive Bayes achieved about 77% and Decision Tree about 71%. The confusion matrix (each column of 6 Authors Suppressed Due to Excessive Length (a) (c) (b) (d) Fig. 1 Distribution of user call activity attributes as (a) total number of outgoing calls, (b) the total (in the logarithmic space) and (c) average duration of each outgoing call and (d) the outgoing degree of each user. the matrix represents the instances in a predicted class while each row represents the instances in an actual class) for SVM is given in Table 1. Note that the Naive Bayes method is a probabilistic learning method providing a probability for each node to belong to one of the subscription type, unlike SVM and AdaBoost, which provide binary values for labelling. For this reason, although less accurate, Naive Bayes is used later to define our graph labelling approach. Table 1 Confusion matrix by SVM. accuracy=0.803 postpaid prepaid postpaid 0.822 0.214 prepaid 0.178 0.786 Besides the above-mentioned attributes, which are related only to call statistics, attributes extracted from the social-communication network may also help our pre- diction. The analysis of the network revealed a strong homophilic structural corre- lation, as calls between the same type of users (prepaid or postpaid) appeared on Prepaid or Postpaid? That is the question 7 average 3 times more often than the ones across the two types of users. The matrix disclosing the fraction of calls by the two type of users is given in Table 2. This highly partitioned structure suggests that potentially the classification accuracy can be further improved by exploiting the observed sparse connectivity between the two user sets. Table 2 Proportion of calls within and between the two types of users. caller prepaid postpaid callee prepaid 0.791 0.173 postpaid 0.209 0.827 To test our conjecture, we extracted postpaid portion attributes, by using the known subscription types of neighbouring users for each user. The portion attributes in focus were: i /ni, c = cpo Fi i /ci, (1) and d = d po Fi i /di, n (resp. Fi d) assigns the portion of the npo i number of calls, and the d po n = npo Fi where Fi c, and Fi i number of postpaid users in the callee set (resp. the cpo i duration of calls to postpaid users) and the ni number of users in the callee set (resp. the ci number of calls, and the di total duration of calls) of a user i. With these extra portion attributes we could largely improve the accuracy of SVM and AdaBoost from ∼ 80% to ∼ 89%. The confusion matrix for SVM is given in Table 3. However, in real settings it is impossible to measure these portion attributes, as they require the knowledge of the service type of each user, which are to be es- timated. This way the outcomes provided by these methods are only informal in terms of our original classification problem as they use information what are assum- ingly not available. On the other hand, these methods can be used to detect false positive cases, where a user was assigned with a subscription type, while having an- other type of contract. This information can be used for direct marketing to provide services to costumers, which might better fit their needs. In any case, the positive results of this initial analysis motivated us to exploit the network topology in our new classification method defined in the next section. Table 3 Confusion matrix for SVM with the proportion attributes. accuracy=0.891 postpaid prepaid postpaid 0.897 0.115 prepaid 0.103 0.885 8 5 Classification with User Attributes and Network Topology Authors Suppressed Due to Excessive Length 5.1 Graph Labeling The key idea here is to exploit both user attributes and the network structure to detect the service type of each user. This is to be done without any prior knowledge about the subscription types of users. To do so, we cast the classification problem as a problem of graph labelling and show that this graph labelling problem is equivalent to the classic network flow problem, namely max-flow min-cut. According to the max-flow min-cut theorem [14], in a flow network, the maximum amount of flow passing from the source s to the sink t is equal to the minimum cut, i.e. the smallest total cost of the links, which if removed would disconnect the source s from the sink t. Fig. 2 Graph labelling for the classification of the service type of each user. Square nodes represent users and circle nodes represent the labels of prepaid and postpaid. Each user is connected in the mobile call network and with both label nodes. A feasible cut will partition the graph so that no flow can go from the source (prepaid) to the sink (postpaid). The minimum cut (the dashed line) is the feasible cut with the least overall cost. To see the connection between the two seemingly irrelevant problems, we take the CDR network G = (V,E) and construct a new graph G(cid:48) = (V(cid:48),E(cid:48)). We add two auxiliary nodes V(cid:48) = V ∪ {s,t}: this two nodes represents the two labels of prepaid and postpaid, which are assigned as the source s and the sink t respec- tively, as illustrated in Figure 2. Initially, we connect each user to both label nodes: E(cid:48) = E ∪{(s,v)∀v ∈ V}∪{(u,t)∀u ∈ V}. We call the links (e = (u,v),u,v ∈ V ) between users as social links and the links (e = (s,u) or e = (u,t), u ∈ V ) between any user and one of the two label nodes as the labelling links. The costs associated to the social and labelling links will be described in the next section. However, in- dependent of the definition of the cost functions, the following theorem guarantees that the minimum cut of the graph in Figure 2 assigns a label to each user. Theorem 1. The minimum cut of a graph like in figure 2 will cut one and only one labelling link of the two labelling links of each user. prepaidpostpaid Prepaid or Postpaid? That is the question 9 Proof. By definition, a cut is feasible if it disconnects the source and the sink, and the minimum cut is the feasible cut with the least total cost. It is trivial that any feasible cut will cut at least one of the two labelling links of each user, however we need to show that any feasible cut that cuts both labelling links from a user is not a minimum cut of the graph. To see this, we consider a subgraph with a pair of doubly connected users. It is clear that the minimum cut of this subgraph can only be one of the four possible cases as shown in Figure 3, all of which cut only one labelling link of each node. Which of these cuts apply in an actual subgraph depends on the cost defined on each link, but in any case, any graph containing such subgraphs must have the minimum cut which holds the same condition. It is important to note that the labelling link which is cut between a node and a label indicates the labelling of the node, which reflects the intuition that cut links tend to have smaller costs. (a) Case 1 (b) Case 2 (c) Case 3 (d) Case 4 Fig. 3 4 possible cases for the feasible cut of the subgraph of a pair of connected users. Note that the labelling link which was cut indicates the labelling of a user. In the last 2 cases, only the one social link with a cross sign is cut. 5.2 Cost Functions and Problem Formulation In order to extend our classification problem as a graph labelling or max-flow min- cut problem, we need to associate a cost to each link in Figure 2. To this end, we use the information about both user attributes and relationships encoded in the social structure. For user u, let xu be the user attribute vector, extracted from call statistics as discussed in Section 4, and fu be the possible label of either prepaid or post- paid, represented by 0 and 1 respectively. On the one hand, we use Naive Bayes to compute the probability P( fuxu) that user u is a prepaid ( fu=0) and postpaid ( fu=1) subscriber. Note that Naive Bayes was adopted as it provides the probability of the classification rather than just a binary classification result. Subsequently, we define the Du cost of each labelling link based on the the probability function P( fuxu) as: Du( fu = 0) = −log(P( fu = 0xu)). Du( fu = 1) = −log(P( fu = 1xu)). (2) ×××××××××× 10 Authors Suppressed Due to Excessive Length This definition assigns a small cost to a labelling link if the probability of a user taking the corresponding label is large. Note that in Naive Bayes, the normalisation condition holds, i.e., P( fu = 0xu) + P( fu = 1xu) = 1, while we force P( fuxu) > 1e− 10 to avoid zero values in the logarithm of Eq.2. On the other hand, to define the cost of a social link, we rely on our earlier ob- servations that postpaid users tend to have 2.5 times larger kout outgoing degrees as compared to prepaid customers, and that the two types of users are sparsely con- nected with each other. The outgoing degree kout(u) of each user u is a simple struc- tural attribute, which turned out to be discriminative here. Thus, we define the cost of a social link w(u,v) as a slightly modified Ising model [10], i.e., w(u,v)( fu = 0, fv = 0) = w(u,v)( fu = 1, fv = 1) = 0, w(u,v)( fu = 0, fv = 1) = w(u,v)( fu = 1, fv = 0) = 1 kout(v) 1 kout(u) , . (3) This definition assigns zero cost to a link, which connects two users of the same label (corresponding to the first two cases in Figure 3 (a) and (b)). Otherwise, when the label is different, a small cost is assigned that is inversely proportional to the outgoing degree of the user labeled as a postpaid customer (corresponding to the last two cases in Figure 3 (c) and (d)). Note that we also tried to define the cost as a measure of social strength between connected users, such as the number of outgoing calls or duration of outgoing calls, but obtained worse performance. With the above defined cost functions for each social link (u,v), the graph la- belling problem in Figure 2 can be interpreted as an energy minimisation problem formulated as: Interestingly, Eq. 4 can be associated to a class of discrete optimisation problems, which has been well studied in the field of computer vision and machine learn- ing [4]. In this terminology, the first term Du, called the data term, reflects the cost of the labelling link between u and label fu, while the second term is the smoothness term, reflecting the costs of social links between users u and v, which encourages connected users to take the same labels. Note that λ is a parameter that controls the trade off between the two terms and its impact on accuracy will be described in the next section. Also note that Eq. 4 can be solved efficiently by any standard max-flow min-cut methods among which the push-relabel algorithm was chosen. In addition, we remark that the cost functions defined in Eq. 2 and 3 do not require the labels of the nodes as inputs as they merely rely on probabilities determined by the Naive Bayes method using user attributes other than portion attributes. min ∑ u∈V Du( fu) + λ ∑ u,v∈V w(u,v)( fu, fv). (4) Prepaid or Postpaid? That is the question 5.3 Implementation and Results 11 Based on the above defined model formulation we can solve the graph labelling problem using standard max-flow min-cut algorithms [3]. Our experiments showed that the graph labelling approach achieved an accuracy of ∼ 84% which is better than using supervised learning on user attributes alone. Note that the parameter λ has an impact on the classification accuracy. If λ = 0, we ignore completely social relationships and graph labelling degenerates to Naive Bayes using user attributes, while if λ = +∞, we ignore completely user attributes and enforce all nodes to take the same label, resulting in an accuracy of ∼ 50% due to the similar sizes of two types of users in our dataset. Thus, we tuned λ by cross validation to our dataset and found the best value to be 100. Enlarging λ by 10 times resulted in an accuracy of ∼ 74%, whereas shrinking λ by 10 times gave us ∼ 80%. Table 4 Confusion matrix by our graph labelling approach. accuracy=0.868 postpaid prepaid postpaid 0.901 0.163 prepaid 0.099 0.837 Table 5 Classification accuracy of different methods using only user attributes. method graph labeling with graph pruning graph labeling SVM with user attributes Naive Bayes with user attributes accuracy 0.868 0.844 0.803 0.770 In addition, we tried to prune the graph by fixing the label of some users under two conditions: if the probability of a user belonging to a class was larger than a threshold τ1 and if the average probability of its neighbours belonging to the same class was larger than another threshold τ2. In our experiments, we set τ1 = 85% and τ2 = 65% which led to fixed labels for about 16% of users. This way of pruning im- proved the accuracy of our prediction to 87%. The confusion matrix of this method is given in Table 4, while Table 5 summarises the accuracy achieved by all different methods in applied so far. Note that the runtime of our approach is about 0.5 hour on a desktop with 32G memory and CPU Xeon of 1.90GHz which is not that slow considering the size of our graph. In particular, we adopted the push-relabel method to solve the max-flow min-cut problem, which has the computational complexity of O(V 2E), where V and E are the number of nodes and edges respectively. Also note that, our graph labelling algorithm utilises the Naive Bayes for modelling the probability that a user is a prepaid or postpaid subscriber. This calculation requires 20,000 randomly sampled training data, as mentioned earlier. However, in the optimisation, we assign labels to 12 Authors Suppressed Due to Excessive Length all 2.5M users including ones in the training set as well. The training samples have no impact to the results as they are less than 1% of the total users and they are only used for learning the cost of labelling links. 6 Subscription type inference of non-company users In most of the countries typically there are several mobile service providers, who compete for customers on the same market. However a provider has access to user data (e.g. subscription type) of its own customers only, while information about the users of other providers are limited to the CDRs between the company and non- company customers, recorded for billing purposes. In this section we use such CDRs to introduce two methods to infer the subscription type of non-company users from a company point of view. Such knowledge is certainly valuable for a provider e.g. to design advertisement strategies to motivate the churning of non-company users. However, this is a difficult problem as the direct verification of inferred subscrip- tion types of non-company users is not possible. To come around this problem, we build on the assumption that call feature patterns, which were shown to be relevant in our classification problem earlier (see Section 4), actually characterise all cus- tomers on the market, not only the company users. This way such features may pro- vide predictive power when characterising calling patterns between company and non-company users, thus can be effectively used for inference and help the design of new validation methods. 6.1 Inference using call statistics In our first method let's consider two mobile providers: A represents our central company with available information about its company users; while B is an external company (of non-company users) with no user information available. First we check whether characteristic call features, observed in Section 4, also differentiate between prepaid and postpaid users in A but considering only inter-company communication. Here we take each users in A from DS2, and using their CDRs only with users in B , we measure the distributions of the number and duration of outgoing calls and their out-degree. As shown in Fig.4 these distributions yet appear to be very different for prepaid and postpaid A users, just as it was shown earlier for intra-company communications. It suggests that these node attributes are not subjective to intra- company communications only but may generalise for any communication tie, even between users of different providers. Based on these observations we assume that these features characterise symmet- rically the communications between any users independent of their provider. How- ever, since we have access to the information of A users only, this is the only set we can use for direct verification of the results of an inference method. Thus in our Prepaid or Postpaid? That is the question 13 (a) (c) (b) (d) Fig. 4 From left to right are the distributions of each user for the total number of outgoing calls, the total (in the logarithmic space) and average duration of each outgoing call and the outgoing degree of each user. Note that these attributes are computed using the data of calls from the operator network of A to that of B, whereas those in Figure 1 are computed using the data of calls within the operator network of A. first approach we took the point of the company B , and we actually try to infer the subscription types of users in A , by only using CDRs between the users of A and B and the characteristic attributes shown in Fig.4. We applied the same machine learn- ing methods with the same setting as described in section 4, but now on the dataset DS2. This experiments showed that our method based merely on statistical node attributes alone can achieve an accuracy of ∼ 68.2% using SVM and Boosting. The confusion matrix by Boosting is given in Table 6. It demonstrates that using only inter-company communications and user attributes, one can infer the subscription types of customers of another provider with relatively high accuracy. Table 6 Confusion matrix by Boosting. accuracy=0.687 postpaid prepaid postpaid 0.682 0.317 prepaid 0.318 0.693 050100150200250300350400number of outgoing calls0.00.10.20.30.40.50.60.70.8fractionprepaidpostpaid012345total duration of outgoing calls (second in log space)0.0000.0050.0100.0150.0200.0250.0300.035fractionprepaidpostpaid050100150200250300350400average duration of outgoing calls (second)0.000.010.020.030.040.050.06fractionprepaidpostpaid0102030405060outgoing degree0.00.10.20.30.40.5fractionprepaidpostpaid 14 6.2 Inference using label propagation Authors Suppressed Due to Excessive Length In our earlier data analysis, in Section 4, we found that calls between the same type of users (prepaid or postpaid) appeared ∼ 3 times more frequently than be- tween users holding different subscriptions. Although this was observed between only users of A , we may assume similar homophilic correlations to be present be- tween users of A and B . Based on this assumption here we present a second method to infer subscription types of non-company users using label propagation together with an indirect validation method. Let's consider a bipartite network G = (VA,VB,EAB), where VA is the set of all A company users, VB is the set of all B non-company users, and EAB contains all directed links between users in VA and VB. A directed link is defined between a ∈ VA and b ∈ VB (resp. between b and a) if a called b (resp. b called a) at least once during the observation. In this network we know the subscription types of all users in VA, while we would like to infer the subscriptions of VB users. As edges in EAB are real social ties inferred from communication records, they are not independent but show degree correlations, could be strong ties of communities, and may show homophilic correlations as we mentioned earlier. The knowledge of subscription types on side A , together with the strong effects of subscription homophily, and the structurally correlated bipartite network provides us a potential way to define a label propagation method using majority rule to infer the subscription types of non-company users in VB. Table 7 Confusion matrix of label inference on the empirical structure. prepaid 0.039 0.966 accuracy=0.964 postpaid prepaid postpaid 0.961 0.034 More precisely, we take all users from VB and their incoming ties, and assign them a label (prepaid or postpaid) corresponding to the majority of the subscription type of their connected friends in VA. In case of equality we selected randomly a label by respecting the overall balance between pre- and postpaid users observed in A . However, even we can assign labels for all the users in VB, we cannot validate the precision of our inference as we do not have access to the subscription types of non-company users. On the other hand, assuming all correlations to be symmetric between the two sets of users, we can use the inferred labels of VB users to assign labels to users in VA applying the same majority rule inference method. After these two ways of label inference we can validate the precision of the inferred labels of users in VA by comparing them to their real subscription types. The result will give us a lower bound for the inference error in VB as erroneous inference propagates also during the process, and the entropy of inference cannot increase during the two ways of inference. As a result we found that on average our method identified the correct labels of 96.4% of users in VA. Our measurements were averaged over 100 Prepaid or Postpaid? That is the question 15 independent realisations with results summarised in the confusion matrix shown in Table 7. This method could give trivial results if two conditions are satisfied at the same time: the average degree in the bipartite network is 1, and all links are bidirectional. In our case, although the 89% of links found to be bidirectional, the average de- gree is relatively high (cid:104)k(cid:105) (cid:39) 2.593 suggesting that the inferred labels are not trivial. This can be further validated by eliminating structural correlations from the bipartite network and see whether we can recover the original results. If the accuracy of infer- ence remains the same in the uncorrelated network, our results are trivial and struc- tural correlations do not play a role here. On the other hand if the accuracy drops in the uncorrelated networks, our results are meaningful. To remove structural correla- tions we used a configuration network model scheme [13], i.e., we choose random pairs of links of the same direction and swapped them while disallowing double links. Repeating this step several times we received a random bipartite structure where the in- and out-degrees of nodes did not change but any structural correla- tion vanished from the network. Repeating our two-way label inference method on 100 of such independently generated random bipartite structures we found that the precision dropped to 56.2%, with a standard deviation of 5%, which suggests that our original findings were significant. For precise results see the confusion matrix in Table 8. Table 8 Confusion matrix of label inference on the randomised structure. prepaid 0.461 0.585 accuracy=0.562 postpaid prepaid postpaid 0.539 0.415 7 Conclusions and Future Work In this paper we presented novel methods to detect prepaid and postpaid customers in mobile phone datasets by exploiting both user attributes and observed structural correlations in the communication network. First we addressed the problem with known inference methods relying on subscription type labels known for some users. We showed that in this case SVM provides us the best solution with 0.891 accuracy. Second, as the main contribution of our work, we addressed a more challenging problem, to infer subscription labels without prior knowledge of subscription types, but only relying on user attributes and observed structural correlations. We cast the classification problem as a problem of graph labelling and solved it by max- flow min-cut algorithms. With this novel methodology we achieved a classification accuracy of ∼ 87% which is about ∼ 7% better than supervised learning on user attributes alone. 16 Authors Suppressed Due to Excessive Length Third, we provided two methods to infer subscription types of non-company users. We showed that using node attributes alone we can achieve already ∼ 70% accuracy of inference. In addition, exploiting present homophilic structural correla- tions, we obtained good accuracy of inference by using a two-ways label propaga- tion method. Our results have certain limitations. As we explained, the incomplete knowl- edge of subscription types of non-company users makes difficult the full verifica- tion of any inference problems. We provided one possible indirect solution here but this should be developed further using more complete datasets. We also generalised some observations on node features and structural correlations for any node and link in the communication network, which should be verified. In addition, the two ways inference method provides more accurate results if the average out-degree of non- company users is high. For some reasons we found its value relatively small, which limits the precision of our inference results. We also note that indirect inference method works in case of competing provides with similar subscription portfolio and user base, thus where our observations on company users the best generalise. In the future, there are several avenues to explore. First, one could extend our approach from binary classification to multi-class classification, which can be sim- ilarly formulated as a graph labelling problem but with more than two label nodes. Such problems are known to be NP-hard but greedy algorithms based on max- flow min-cut have been proposed to achieve approximate solutions [4]. Second, our dataset is intrinsically dynamical and contains CDRs over one month, what we all used to predicting user subscription types. It would be interesting to study the impacts of the dynamics of the mobile call data over time for longer periods to understand how temporal patterns of communications can improve our predictions. Possible structural biases in the network between users of different customers could be also a direction to explore. Our aim here was to contribute to the more general discussion of user attribute inference and to give possible directions for potential future applications in behavioural prediction and personal marketing. Acknowledgment We acknowledge Grandata to share the data and M. Fixman for his technical sup- port. This research project was partially granted by the SticAmSud UCOOL project, INRIA, SoSweet (ANR-15-CE38-0011-01) and CODDDE (ANR-13-CORD-0017- 01). Prepaid or Postpaid? That is the question Authors' contribution 17 All authors read and verified the manuscript. YL, WD, MK, CS and EF participated in the writing; YL, WD, MK and EF designed the research; and YL run all numerical calculations. References 1. Ahmad, M.A., Borbora, Z., Srivastava, J., Contractor, N.: Link prediction across multiple so- cial networks. In: 2010 IEEE International Conference on Data Mining Workshops (Dec 2010) 2. Bin Bi, Milad Shokouhi, M.K.T.G.: Inferring the demographics of search users. In: 22nd In- ternational World Wide Web Conference (2013) 3. Boykov, Y., Kolmogorov, V.: An experimental comparison of min-cut/max-flow algorithms for energy minimization in vision. IEEE Trans. Pattern Anal. Mach. Intell. 26(9), 1124–1137 (Sep 2004) 4. Boykov, Y., Veksler, O., Zabih, R.: Fast approximate energy minimization via graph cuts. IEEE Trans. Pattern Anal. Mach. Intell. 23(11), 1222–1239 (Nov 2001) 5. Burton, S.H., Giraud-Carrier, C.G.: Discovering social circles in directed graphs. ACM Trans. Knowl. Discov. Data 8(4) (Aug 2014) 6. Chen, X., Wang, Y., Agichtein, E., Wang, F.: A comparative study of demographic attribute inference in twitter. In: Proceedings of the Ninth International Conference on Web and Social Media (2015) 7. Dong, Y., Tang, J., Wu, S., Tian, J., Chawla, N.V., Rao, J., Cao, H.: Link prediction and recommendation across heterogeneous social networks. In: Proceedings of the 2012 IEEE 12th International Conference on Data Mining (2012) 8. Dong, Y., Yang, Y., Tang, J., Yang, Y., Chawla, N.V.: Inferring user demographics and social strategies in mobile social networks. In: SIGKDD (2014) 9. Eagle, N., Pentland, A.S., Lazer, D.: Inferring friendship network structure by using mobile phone data 106(36), 15274–15278 (Sep 2009) 10. Kolmogorov, V., Zabih, R.: What energy functions can be minimized via graph cuts? IEEE Trans. Pattern Anal. Mach. Intell. 26(2), 65–81 (2004) 11. Kong, X., Zhang, J., Yu, P.S.: Inferring anchor links across multiple heterogeneous social networks. In: Proceedings of the 22Nd ACM International Conference on Information and Knowledge Management (2013) 12. Malmi, E., Weber, I.: You are what apps you use: Demographic prediction based on user's 13. Newman, M.: Networks: An Introduction. Oxford University Press (2010) 14. Papadimitriou, C.H., Steiglitz, K.: Combinatorial Optimization: Algorithms and Complexity. apps. CoRR (2016) Prentice-Hall, Inc. (1982) 15. Sun, Y., Aggarwal, C.C., Han, J.: Relation strength-aware clustering of heterogeneous infor- mation networks with incomplete attributes. Proc. VLDB Endow. 5(5) (Jan 2012) 16. Tang, J., Lou, T., Kleinberg, J.: Inferring social ties across heterogenous networks. In: Pro- ceedings of the Fifth ACM International Conference on Web Search and Data Mining (2012) 17. Xu, Z., Ke, Y., Wang, Y., Cheng, H., Cheng, J.: A model-based approach to attributed graph clustering. In: Proceedings of the 2012 ACM SIGMOD International Conference on Manage- ment of Data (2012) 18. Yang, J., McAuley, J., Leskovec, J.: Community Detection in Networks with Node Attributes. In: IEEE International Conference On Data Mining (ICDM) (2013) 19. Xu, H., Yang, Y., Wange, L., Liu, W.: Node classification in social network via a factor graph model. In: Advances in Knowledge Discovery and Data Mining (2013)
1409.2186
5
1409
2015-06-17T17:32:57
Universal Phase Transition in Community Detectability under a Stochastic Block Model
[ "cs.SI", "physics.soc-ph" ]
We prove the existence of an asymptotic phase transition threshold on community detectability for the spectral modularity method [M. E. J. Newman, Phys. Rev. E 74, 036104 (2006) and Proc. National Academy of Sciences. 103, 8577 (2006)] under a stochastic block model. The phase transition on community detectability occurs as the inter-community edge connection probability $p$ grows. This phase transition separates a sub-critical regime of small $p$, where modularity-based community detection successfully identifies the communities, from a super-critical regime of large $p$ where successful community detection is impossible. We show that, as the community sizes become large, the asymptotic phase transition threshold $p^*$ is equal to $\sqrt{p_1\cdot p_2}$, where $p_i~(i=1,2)$ is the within-community edge connection probability. Thus the phase transition threshold is universal in the sense that it does not depend on the ratio of community sizes. The universal phase transition phenomenon is validated by simulations for moderately sized communities. Using the derived expression for the phase transition threshold we propose an empirical method for estimating this threshold from real-world data.
cs.SI
cs
Universal Phase Transition in Community Detectability under a Stochastic Block Model Pin-Yu Chen and Alfred O. Hero III Department of Electrical Engineering and Computer Science University of Michigan, Ann Arbor, MI 48109, USA We prove the existence of an asymptotic phase transition threshold on community detectabil- ity for the spectral modularity method [M. E. J. Newman, Phys. Rev. E 74, 036104 (2006) and Proc. National Academy of Sciences. 103, 8577 (2006)] under a stochastic block model. The phase transition on community detectability occurs as the inter-community edge connection probability p grows. This phase transition separates a sub-critical regime of small p, where modularity-based community detection successfully identifies the communities, from a super-critical regime of large p where successful community detection is impossible. We show that, as the community sizes become large, the asymptotic phase transition threshold p∗ is equal to √p1p2, where pi (i = 1, 2) is the within-community edge connection probability. Thus the phase transition threshold is universal in the sense that it does not depend on the ratio of community sizes. The universal phase transi- tion phenomenon is validated by simulations for moderately sized communities. Using the derived expression for the phase transition threshold we propose an empirical method for estimating this threshold from real-world data. PACS numbers: 89.75Hc, 02.70Hm, 64.60.aq, 89.20.-a I. INTRODUCTION Community detection is an active research field that arises in technological, social, and biological networks. The goal of community detection is to detect tightly connected sub- graphs in a graph [1]. The spectral modularity method pro- posed by Newman [2, 3] is widely applied to community detec- tion. It has been observed that community detectability (i.e., the fraction of correctly identified nodes) degrades rapidly as the number of inter-community edges increases beyond a certain critical value [4 -- 12]. This paper establishes a mathe- matical expression for the critical phase transition threshold in modularity-based community detection under a stochas- tic block model. This phase transition threshold governs the community modularity measure of the graph as a function of the respective edge connection probabilities p1 and p2 within community 1 and community 2. Defining p as the edge con- nection probability between the two communities the critical phase transition threshold on p takes on the simple asymp- totic form p∗ = √p1p2, in the limit as the two community sizes converge (at comparable rate) to infinity. Remarkably, p∗ does not depend on the community sizes, and in this sense it is a universal threshold. Let n denote the total number of nodes in an undirected graph and let A be the associated adjacency matrix. Specif- ically, A is an n × n binary symmetric matrix characterizing the connectivity structure of a graph, where Aij = 1 if an edge exists between node i and node j, and Aij = 0 otherwise. Newman proposed a measure called modularity that evaluates the number of excessive edges of a graph compared with the corresponding degree-equivalent random graph. More specif- ically, define the modularity matrix as B = A − bddT , where d is the degree vector of the graph and b is the reciprocal of the total number of edges in the graph. The last term bddT can be viewed as the expected adjacency matrix of the degree- equivalent random graph. Newman proposed to compute the largest eigenvector of B and perform K-means clustering [13] or take the sign function on this vector to cluster the nodes into two communities. Since the n-dimensional vector of all ones, 1n, is always in the null space of B, i.e, B1n = 0n, where 0n is the n-dimensional vector of all zeros, the (unnor- malized) modularity is the largest eigenvalue of B and has the representation λmax(B) = max xT x=1, xT 1n=0 xT Bx. (1) Consider a stochastic block model [14] consisting of two community structures parameterized by edge connection probability pi within community i (i = 1, 2) and edge con- nection probability p between the two communities. Let ni denote the size of community i such that n1 + n2 = n. The overall n × n adjacency matrix of the entire graph can be represented as CT A2(cid:21) , A =(cid:20)A1 C (2) where Ai is the ni-by-ni adjacency matrix of an Erdos-Renyi random graph with edge connection probability pi and C is the n1-by-n2 adjacency matrix of the inter-community edges where each entry in C is a Bernoulli(p) random variable. A similar network model is studied in [15] for interconnected net- works. However, in [15] the communities (subnetworks) have the same size and the inter-community edges are known (i.e., non-random). The main purpose of [15] is to study the eigen- structure of the overall graph Laplacian matrix with different interconnected edge strengths, as contrasted to community detection. In [16], the network model (2) is used to study community detectability of spectral algorithms based on the eigenvectors of the graph Laplacian matrix. The fundamental limits on community detectability have been investigated for the spectral modularity method under more restrictive assumptions [6, 9] than assumed in this pa- per. In [9], the community detectability of the spectral mod- ularity method is studied in sparse random networks where the average degree is fixed and the two communities have the same community size and identical within-community edge connection probability, i.e., n1 = n2, p1 = p2 = O( 1 n ), and p = O( 1 n ). The critical value for community detectability is shown to depend on the average degree of the within- community and inter-community edges. Similar closed-form phase transition expressions have been found under the same network assumption in [6, 7, 10]. The planted clique detection problem in [17] is a further restriction of the stochastic block model when p2 = p. For spectral methods that use the eigenvectors of linear opera- tors associated with the graph for community detection (e.g., the modularity, adjacency, Laplacian, or normalized Lapla- cian matrices), the phase transition threshold under the gen- eral stochastic block model can be derived by investigating the eigenvalue spectra [18]. Different from the aforementioned works, our network model relaxes the assumptions of identical community size and within-community edge connection probability, and we assume that the parameters p1 and p2 are fixed. Under this general setting, we prove an asymptotic universal phase tran- sition threshold of p on community detection using the spec- tral modularity method, where the asymptotic critical value of p is p∗ = √p1p2. We also derive asymptotic forms for the modularity and the largest eigenvector of B, which are directly affected by the phase transition phenomenon. Note that the same phase transition threshold has been derived in [19] in terms of the consistency of the modularity and the loglikelihood of the degree corrected stochastic model [20], whereas in this paper we explicitly show that the spectral modularity method can achieve the same phase transition threshold. Also note that under the same stochastic block model (2), the phase transition threshold of the spectral mod- ularity method established in this paper coincides with the phase transition threshold of several spectral community de- tection methods derived from Eq. (6) in [18]. This suggests that this phase transition threshold might be universal for many spectral methods. II. PHASE TRANSITION ANALYSIS Using the network model in (2), let d = A1n = [dT 2 ]T denote the degree vector of the graph with d1 ∈ Rn1 and 2 1n2 )−1. Let d2 ∈ Rn2 . Then b = (1T edi = Ai1ni denote the degree vector of community i. Since A1n = d, with (2) the degree vectors d1, d2, ed1, and ed2 satisfy the following equations: n A1n)−1 = (dT 1 1n1 + dT 1 dT d1 =ed1 + C1n2 and d2 =ed2 + CT 1n1 . i 1ni )−1. The modularity matrix of community i i . Using these notations, the modularity matrix of the entire graph can be represented as (3) Let bi = (edT is denoted by Bi = Ai − biediedT B ="B1 + b1ed1edT 1 − bd1dT CT − bd2dT 1 1 2# . (4) 2 C − bd1dT B2 + b2ed2edT 2 − bd2dT Let y = [yT 2 ]T denote the largest eigenvector of B, where y1 ∈ Rn1 and y2 ∈ Rn2 . Following the definition of 1 yT modularity in (1) and (4), y = arg maxx Γ(x), where 2 x2)2 Γ(x) = xT 1 x1)2 − b(dT 1 x1 + xT 2 B2x2 + b1(edT 2 x2)2 + 2xT 2 x2 − 1) − ν(xT 1 B1x1 + xT − b(dT − µ(xT 2 ]T , x1 ∈ Rn1 , and x2 ∈ Rn2 . µ and ν are and x = [xT Lagrange multipliers of the constraints xT x = 1 and xT 1n = 0 in (1), respectively. 1 x1)2 + b2(edT 1 Cx2 − 2b(dT 1 1n1 + xT 2 1n2 ), 1 x1)(dT 1 xT 2 x2) (5) Differentiating (5) with respect to x1 and x2 respectively, and substituting y to the equations, we obtain + 2Cy2 − 2µy1 − ν1n1 = 0n1 ; 2B1y1 + 2b1(edT 2B2y2 + 2b2(edT + 2CT y1 − 2µy2 − ν1n2 = 0n2 . 1 y1)ed1 − 2b(dT 2 y2)ed2 − 2b(dT 1 y1)d1 − 2b(dT 2 y2)d1 2 y2)d2 − 2b(dT 1 y1)d2 (6) (7) n1 and left multiplying (7) by 1T n2 i 1ni )−1, we have 1 1n1 ) + 21T n1 Cy2 Left multiplying (6) by 1T and recalling that Bi1ni = 0ni and bi = (edT 2(edT 1 y1) − 2b(dT − 2µyT 2(edT 2 y2) − 2b(dT − 2µyT 1 y1)(dT 1 1n1 − νn1 = 0; 2 y2)(dT 2 1n2 − νn2 = 0. 1 1n1 ) − 2b(dT 2 1n2 ) − 2b(dT 2 y2)(dT 1 y1)(dT 2 1n2 ) + 21T (8) n2 CT y1 (9) Summing (8) and (9) and using (3) gives ν = 0. Left mul- tiplying (6) by yT 2 , substi- tuting ν = 0 and summing the equations, with (4) we have µ = λmax(B). 1 and left multiplying (7) by yT Let ¯C = p1n1 1T √n1n2(cid:19) a.s.−→ p and σi(cid:18) C proved in Appendix A. Furthermore, by Talagrand's concen- tration theorem [22], n2 , a matrix whose elements are the means of entries in C. Let σi(M) denote the i-th largest singular value of a rectangular matrix M and write C = ¯C+ ∆, where ∆ = C − ¯C. Latala's theorem [21] implies that the expected √n1 n2(cid:17) converges to 0 as n1 and n2 approach to value of σ1(cid:16) ∆ √n1 n2(cid:17)i → 0 as n1, n2 → ∞. This is infinity, denoted Ehσ1(cid:16) ∆ σ1(cid:18) C √n1n2(cid:19) a.s.−→ 0, ∀i ≥ 2 (10) when n1, n2 → ∞, where a.s.−→ means almost sure convergence. is maximal when n1 = n2 because n1 + n2 ≥ 2√n1n2 and the n2 → c > 0 as n1, n2 → ∞. This means the community sizes grow with comparable rates. As proved in [23], the singular vectors of C and ¯C are close to each other in the sense that the square of inner product of their left/right singular vectors converges to 1 almost surely when √n1n2p → ∞. Consequently, the This is proved in Appendix B. Note that the convergence rate Throughout this paper we further assume n1 equality holds if n1 = n2. concentration results in (10) and [23] imply that C1n2 n2 a.s.−→ p1n1 and CT 1n1 n1 a.s.−→ p1n2 . (11) Furthermore, since under the stochastic block model set- ting each entry of the adjacency matrix Ai in (2) is a Bernoulli(pi) random variable, following the same concentra- tion arguments in (10) and (11) we have A11n1 n1 a.s.−→ p11n1 and A21n2 n2 a.s.−→ p21n2 . (12) By the fact that edi = Ai1ni , (12) implies that a.s.−→ p21n2 . a.s.−→ p11n1 and ed2 ed1 n2 n1 Applying (11), (12) and (13) to (3) and recalling that n1 c > 0, we have n2 → (13) d1 n1 a.s.−→(cid:16)p1 + p c(cid:17) 1n1 and d2 n2 a.s.−→ (p2 + cp) 1n2 . (14) Therefore the reciprocal of the total degree in the graph b has the relation In the sub-critical regime, observe that λmax(B) converges n almost surely such that the corresponding to p1 p2−p cp1+2p+ 2 p2 c asymptotic largest eigenvector y of B remains the same (unique up to its sign) for different p. Left multiplying (6) by yT 2 , summing these two equations, and using the limiting expressions (4), (11), (12), (13), (14), (15), and (18), in the sub-critical regime, we have 1 and left multiplying (7) by yT yT 1 B1y1 n + yT 2 B2y2 n + f (p) a.s.−→ 0, √c (cid:17)2 1 1n1)2 (yT n (20) Since − 1#. 2 c " (cid:16)√c+ 1 p2 where f (p) = p1p2−p cp1+2p+ f (p) is a Laurent polynomial of p with finite powers, and (20) has to be satisfied over all values of p in the sub-critical regime, n1n2b = n1n2 dT 1 1n1 + dT 2 1n2 a.s.−→ 1 cp1 + 2p + p2 c . (15) yT 1 B1y1 n + yT 2 B2y2 n a.s.−→ 0 and f (p) a.s.−→ 0. (21) Substituting these limits to (8) and (9) and recalling that ν = 0 and yT 1 1n1 = −yT yT 1 1n1(cid:18) µ 2 1n2(cid:18) µ yT n − n − 2 1n2 , we have p1p2 − p2 cp1 + 2p + p2 p1p2 − p2 cp1 + 2p + p2 c (cid:19) a.s.−→ 0; c (cid:19) a.s.−→ 0. (16) (17) Since µ = λmax(B), for each inter-community edge connection probability p, one of the two cases below has to be satisfied: λmax(B) Sub-critical regime: n Super-critical regime: yT 1 1n1 p1p2 − p2 cp1 + 2p + p2 c 2 1n2 a.s.−→ a.s.−→ 0 and yT (18) a.s.−→ 0 (19) Furthermore, we can show that, in the sub-critical regime, y1 and y2 converge almost surely to constant vectors with opposite signs, r nn1 n2 y1 a.s.−→ ±1n1 and r nn2 n1 y2 a.s.−→ ∓1n2 . (22) This is proved in Appendix C. Therefore, in the sub-critical regime the two communities can be almost perfectly detected. On the other hand, in the super-critical regime the spectral modularity method fails to detect the two communities since by (19) y1 and y2 must have both positive and negative en- tries. Next we derive the asymptotic universal phase transition threshold p∗ for transition from the sub-critical regime to the super-critical regime that occurs as p increases. Note that in the super-critical regime, since yT using (1), (4), (11), (12), (13) and (14) we have a.s.−→ 0 and yT a.s.−→ 0, 2 1n2 1 1n1 λmax(B) n 1 1 = 1 (p11n1 1T 1 B1y1 + yT 2 y2)2 − b(dT nhyT nnyT a.s.−→ − bh(n1p1 + n2p) yT −2bh(n1p1 + n2p) yT 1 y1)2 + b2(edT 2 B2y2 + b1(edT n2 − p21n2 1T n1 − p11n1 1T − bh(n2p2 + n1p) yT 1 1n1i2 2 1n2i2 2 1n2io 1 1n1ih(n2p2 + n1p) yT n1 )y1 + yT 2 (p21n2 1T = 0. 1 y1)2 − b(dT 2 y2)2 + 2yT n2 )y2 + b1(n1p1yT 1 y1)(dT 1 Cy2 − 2b(dT 1 1n1 )2 + b2(n2p2yT 2 1n2 )2 2 y2)i + 2p(yT 1 1n1 )(yT 2 1n2 ) (23) Consequently, by (18) and (23), the phase transition occurs at p = p∗ almost surely when p1 p2−p∗ 2 = 0. This implies cp1+2p∗+ an asymptotic universal phase transition threshold on com- munity detectability: p2 c p∗ a.s.−→ √p1p2 as n1, n2 → ∞ and n1 n2 → c > 0. Note that the limit (24) does not depend on the community sizes. In this sense, the phase transitions are universal as they only depend on the (24) within-community connection probabilities p1 and p2. nǫ ) and p = O( 1 Moreover, the same phase transition results hold for a more general setting where pi = O( 1 nǫ ) for any ǫ ∈ [0, 1) by following the same derivation procedures. As a comparison, the phase transition threshold under the sparse network setting, where pi = O( 1 n ) [6 -- 11], is different from the threshold established in this paper where pi = O( 1 nǫ ) for any ǫ ∈ [0, 1). Also note that when pi = O( 1 nǫ ) for any ǫ ∈ [0, 1), the community detectability undergoes an abrupt transition nǫ ) and p = O( 1 nǫ ) and p = O( 1 n ) and p = O( 1 ) B ( x a m λ 0.2 n 0 −0.2 0 0.05 0.1 0.15 1 0.8 0.6 y t i l i b a t c e t e d 0 0.05 0.1 0.15 i i y Tn 1 20 0 −20 0 0.05 0.1 0.15 (a) 0.2 p (b) 0.2 p (c) 0.2 p simulation p1p2−p2 cp1+2p+ p2 c 0.25 0.3 0.35 0.4 0.25 0.3 0.35 T y1 1n1 T y2 1n2 ±p n1n2 n 0.4 0.25 0.3 0.35 0.4 n converges to FIG. 1. Validation of theoretical critical phase transition threshold (24) for two communities generated by a stochastic block model. The curves represent averages over 100 realiza- tions of the model. Here n1 = n2 = 2000 and p1 = p2 = 0.25 so that the predicted critical phase transition is p∗ = 0.25. (a) When p < p∗, λmax(B) as predicted in (18). When p > p∗, λmax(B) converges to 0 as predicted by (23). (b) Fraction of nodes that are correctly identified using the spectral modularity method. Community detectability undergoes a phase transition from perfect detectability to low detectability at p = p∗. (c) The spectral modularity method fails to detect the communities when p > p∗ since the com- ponents of the largest eigenvector of B, y1 and y2, undergo transitions at p = p∗ as predicted by (19) and (22). p1 p2−p cp1+2p+ p2 c n 2 at the threshold whereas the transition is more smooth for sparse networks. III. PERFORMANCE EVALUATION A. Numerical Results We validate the asymptotic phase transition phenomenon predicted by our theory, and in particular the critical phase transition threshold (24), showing that the asymptotic the- ory provides remarkably accurate predictions for the case of finite small community sizes. Fig. 1 (a) shows that λmax(B) converges to converges when p < p∗ and λmax(B) n 2 n p1p2−p cp1+2p+ p2 c to 0 when p > p∗, as predicted by (16) and (23). Fig. 1 (b) shows the phase transition from perfect detectability to low detectability at the critical value p = p∗. The numerical phase transition thresholds are accurately predicted by (24). Fig. 1 (c) further validates the predictions in (19) and (22) that y1 and y2 converge almost surely to constant vectors with opposite signs in the sub-critical regime of p < p∗ and yT 2 1n2 converge to 0 almost surely in the super- critical regime of p > p∗. Similarly in Fig. 2, the results are shown for a different stochastic block model where the sizes of the two communities are not the same. These results 1 1n1 and yT 0.2 n 0 ) B ( x a m λ −0.2 0 1 0.8 0.6 y t i l i b a t c e t e d i i y Tn 1 20 0 −20 0 0 (a) p (b) p (c) p 0.1 0.2 0.1 0.2 0.1 0.2 simulation p1p2−p2 cp1+2p+ p2 c 0.3 0.4 0.5 0.3 0.4 0.5 T y1 1n1 T y2 1n2 ±p n1n2 n 0.3 0.4 0.5 FIG. 2. Validation of theoretical critical phase transition threshold (24) for two communities generated by a stochastic block model. The curves represent averages over 100 realiza- tions of the model. Here n1 = 1000, n2 = 2000, p1 = 0.5, and p2 = 0.25 so that the predicted critical phase transition is p∗ = 0.3536. Similar phase transition phenomenon can be observed for this network setting. validate that the asymptotic phase transition threshold p∗ in (24) is a universal phenomenon that does not depend on the community sizes. We have observed (see Appendix D) that the asymptotic phase transition expression in (24) is accurate even in cases of relatively small community sizes, e.g. down to sizes as small as 100. B. Empirical Estimator of the Phase Transition Threshold Using the derived expression of the phase transition thresh- old in (24), we propose an empirical method for estimating the threshold in order to evaluate the reliability of commu- nity detection on real-world data a posteriori. Let bni and bmi denote the size and the number of edges of the identified community i. Define the empirical estimators ; bp = number of identified external edges/bn1bn2; bpi = bmi bn2 bp∗ =pbp1bp2. i We apply these estimators to the political blog data in [24], where this dataset contains 1222 blogs, labeled as either con- servative or liberal, and an edge corresponds to a hyperlink reference between blogs. The detectability using the spec- tral modularity method is 0.9419 (the labels are predicted by taking the sign function on the leading eigenvector of the modularity matrix). The corresponding empirical estimates The high detectability of the spectral modularity method is are bp = 0.0042, bp1 = 0.0244, bp2 = 0.0179, and bp∗ = 0.0209. consistent with the fact that the empirical estimatebp is below (25) (26) (27) the empirical phase transition threshold bp∗. IV. CONCLUSION This paper establishes a universal phase transition thresh- a.s.−→ √p1p2 on community detectability using the spec- old p∗ tral modularity method for a general stochastic block model. The critical phase transition is universal in the sense that it does not depend on the community sizes. An empirical method is proposed to estimate the phase transition thresh- old from real-world data. ACKNOWLEDGMENTS This work was supported in part by the US Army Research Office under grant W911NF-12-1-0443. [1] S. Fortunato, Physics Reports 486, 75 (2010). [2] M. E. J. Newman, Phys. Rev. E 74, 036104 (2006). [3] M. E. J. Newman, Proc. National Academy of Sciences 103, 8577 (2006). [4] P. J. Bickel and A. Chen, Proceedings of the National Academy of Sciences 106, 21068 (2009). [5] P. Ronhovde and Z. Nussinov, Phys. Rev. E 80, 016109 (2009). [6] A. Decelle, F. Krzakala, C. Moore, and L. Zdeborov´a, Phys. Rev. Lett. 107, 065701 (2011). [7] A. Decelle, F. Krzakala, C. Moore, and L. Zdeborov´a, Phys. Rev. E 84, 066106 (2011). [8] P. Zhang, F. Krzakala, J. Reichardt, and L. Zdeborov, Journal of Statistical Mechanics: Theory and Experi- ment , P12021 (2012). [9] R. R. Nadakuditi and M. E. J. Newman, Phys. Rev. Lett. 108, 188701 (2012). [10] F. Krzakala, C. Moore, E. Mossel, J. Neeman, A. Sly, L. Zdeborov, and P. Zhang, Proceedings of the National Academy of Sciences 110, 20935 (2013). [11] F. Radicchi, Phys. Rev. E 88, 010801 (2013). [12] F. Radicchi, EPL (Europhysics Letters) 106, 38001 (2014). [13] J. A. Hartigan and M. A. Wong, JSTOR: Applied Statis- tics 28, 100 (1979). [14] P. W. Holland, K. B. Laskey, and S. Leinhardt, Social Networks 5, 109 (1983). [15] F. Radicchi and A. Arenas, Nature Physics 9, 717 (2013). [16] P.-Y. Chen and A. O. Hero, arXiv:1409.3207 (2014). [17] R. R. Nadakuditi, in IEEE Statistical Signal Processing Workshop (SSP) (2012) pp. 129 -- 132. [18] T. P. Peixoto, Phys. Rev. Lett. 111, 098701 (2013). [19] Y. Zhao, E. Levina, and J. Zhu, The Annals of Statistics 40, 2266 (2012). [20] B. Karrer and M. E. J. Newman, Phys. Rev. E 83, 016107 (2011). [21] R. Latala, Proc. Am. Math. Soc. 133, 1273 (2005). [22] M. Talagrand, Publications Mathmatiques de l'Institut des Hautes tudes Scientifiques 81, 73 (1995). [23] F. Benaych-Georges and R. R. Nadakuditi, Journal of Multivariate Analysis 111, 120 (2012). [24] L. A. Adamic and N. Glance, in ACM Proceedings of the 3rd International Workshop on Link Discovery (LinkKDD) (2005) pp. 36 -- 43. [25] R. A. Horn and C. R. Johnson, Matrix Analysis (Cam- bridge University Press, 1990). [26] S. Resnick, A Probability Path (Birkhauser Boston, 2013). when n1, n2 → ∞. Appendix C: Proof of (22) yT n n n1 n2 yT y2 y1 the and 1 B1 y1 such a.s.−→ 0 result by showing We prove 2 B2 y2 and q nn2 that q nn1 a.s.−→ 0 a.s.−→ a.s.−→ ∓1n2 due to the facts that ±1n1 the vector of all ones is always in the null space of a 1 1n1 + yT modularity matrix and yT 2 1n2 = 0. We prove this statement by contradiction. Assume y1 and y2 converge almost surely to other vectors such that yT n → c4 6= 0 and yT n → c5 6= 0 and c4 + c5 = 0 in order to satisfy (21). By the concentration results in (12) and (13), we have 1 B1y1 2 B2 y2 yT 1 B1y1 n = yT 1 (cid:16)A1 − b1ed1edT 1(cid:17) y1 1 (cid:16)p11n1 1T n1 − 1 2p1 · n1 n yT n n1 a.s.−→ 2p2 11n1 1T n1(cid:17) y1 = 0, (C1) 1 B1 y1 and similarly yT tion that yT n y1 foreq nn1 n2 2 B2y2 n a.s.−→ 0, which contradicts the assump- a.s.−→ c5 6= 0. There- 2 B2 y2 a.s.−→ c4 6= 0 and yT a.s.−→ ±1n1 andq nn2 n1 n y2 a.s.−→ ∓1n2 . Appendix D: The Effect of Community Size on Phase Transition To investigate the effect of community size on phase tran- sition, we generate synthetic communities from the stochastic block model with different community sizes by fixing c = 1 and p1 = p2 = 0.25. The predicted phase transition thresh- old in (24) is p∗ = 0.25. The results (averaged for 100 runs) are shown in Fig. 3-7. The phase transition is apparent for small community size in the sense that the spectral modu- larity method fails to detect the communities in the super- critical regime (i.e., the p > p∗ regime). In the sub-critical regime (i.e., the p ≤ p∗ regime), we observe an intermedi- ate regime of community detectability for small community size, and this intermediate regime vanishes as we increase the community size. This can be explained by the fluctuation of finite community size on the concentration results in (18), (19), (22), and (24). By concentration theory the fluctuation decreases with the increase of community size, and an abrupt transition occurs at the phase transition threshold p∗ when n1, n2 → ∞ and n1 n2 → c > 0. Appendix A: Proof of the fact that Ehσ1(cid:16) ∆ √n1 n2(cid:17)i → 0 as n1, n2 → ∞ Since ∆ = C − ¯C, we have ∆ij = 1 − p with probability p and ∆ij = −p with probability 1 − p. Latala's theorem [21] states that for any random matrix M with statistically independent and zero mean entries, there exists a positive constant c1 such that E(cid:2)M2 ij(cid:3) (A1) j sXi E [σ1(M)] ≤c1max i sXj E(cid:2)M2 ij(cid:3) + max ij(cid:3) . + 4sXij E(cid:2)M4 ), maxjqPi ij(cid:3) = O( 1 E(cid:2)M2 ), and 4qPij ij(cid:3) = O( E(cid:2)M4 √n1 n2(cid:17)i → 0 as n1, n2 → ∞. have maxiqPj Ehσ1(cid:16) ∆ O( 1 √n2 4√n1 n2 √n1 ). 1 It is clear that E [∆ij ] = 0 and each entry in ∆ is independent. By using M = ∆ in Latala's theorem, since p ∈ [0, 1], we √n1 n2 E(cid:2)M2 ij(cid:3) = Therefore Appendix B: Proof of (10) Talagrand's concentration theorem is stated as follows. Let g : Rk 7→ R be a convex and 1-Lipschitz function. Let x ∈ Rk be a random vector and assume that every element of x satisfies xi ≤ K for all i = 1, 2, . . . , k, with probability one. Then there exist positive constants c2 and c3 such that for any ǫ > 0, Pr (g(x) − E [g(x)] ≥ ǫ) ≤ c2 exp(cid:18)−c3ǫ2 K 2 (cid:19) . (B1) ∆ij √n1 n2 , we have √n1 n2(cid:17)i → 0 and It is well-known that the largest singular value of a matrix M can be represented as σ1(M) = maxzT z=1 Mz2 [25] so that σ1(M) is a convex and 1-Lipschitz function. Recall that ∆ij = 1−p with probability p and ∆ij = −p with probability 1−p. Therefore applying Talagrand's theorem by substituting M = ∆ √n1 n2 √n1 n2 ≤ 1 and using the facts that Ehσ1(cid:16) ∆ √n1n2(cid:19) ≥ ǫ(cid:19) ≤ c2 exp(cid:0)−c3n1n2ǫ2(cid:1) . Pr(cid:18)σ1(cid:18) ∆ , Pn1 ,n2 c2 exp(cid:0)−c3n1n2ǫ2(cid:1) < ∞. Hence, by Borel- √n1n2(cid:17) a.s.−→ 0 when n1, n2 → ∞. √n1 n2(cid:17) a.s.−→ Cantelli lemma [26], σ1(cid:16) ∆ σi( ¯C+∆)−σi( ¯C) ≤ σ1(∆) for all i, and as σ1(cid:16) ∆ √n1n2(cid:19) = p; σ1(cid:18) C σi(cid:18) C √n1n2(cid:19) = σ1(cid:18) ¯C + ∆ √n1n2(cid:19) a.s.−→ 0, ∀i ≥ 2 Note that, since for any positive integer n1, n2 > 0 n1n2 ≥ √n1n2(cid:19) a.s.−→ σ1(cid:18) ¯C Finally, a standard matrix perturbation theory result [25] is 0, we have (B3) (B2) n1+n2 2 ) B ( x a m λ 0.2 n 0 −0.2 0 0.05 0.1 0.15 1 0.8 0.6 y t i l i b a t c e t e d 0 0.05 0.1 0.15 i i y Tn 1 10 0 −10 0 0.05 0.1 0.15 (a) 0.2 p (b) 0.2 p (c) 0.2 p simulation p1p2−p2 cp1+2p+ p2 c 0.25 0.3 0.35 0.4 0.25 0.3 0.35 T y1 1n1 T y2 1n2 ±p n1n2 n 0.4 0.25 0.3 0.35 0.4 FIG. 3. n1 = 100, n2 = 100, p1 = 0.25, and p2 = 0.25. ) B ( x a m λ 0.2 n 0 −0.2 0 0.05 0.1 0.15 1 0.8 0.6 y t i l i b a t c e t e d 0 0.05 0.1 0.15 i i y Tn 1 10 0 −10 0 0.05 0.1 0.15 (a) 0.2 p (b) 0.2 p (c) 0.2 p simulation p1p2−p2 cp1+2p+ p2 c 0.25 0.3 0.35 0.4 0.25 0.3 0.35 T y1 1n1 T y2 1n2 ±p n1n2 n 0.4 0.25 0.3 0.35 0.4 FIG. 4. n1 = 200, n2 = 200, p1 = 0.25, and p2 = 0.25. 0.2 n 0 ) B ( x a m λ −0.2 0 0.05 0.1 0.15 1 0.8 0.6 y t i l i b a t c e t e d 0 0.05 0.1 0.15 i i y Tn 1 20 0 −20 0 0.05 0.1 0.15 (a) 0.2 p (b) 0.2 p (c) 0.2 p simulation p1p2−p2 cp1+2p+ p2 c 0.25 0.3 0.35 0.4 0.25 0.3 0.35 T y1 1n1 T y2 1n2 ±p n1n2 n 0.4 0.25 0.3 0.35 0.4 FIG. 5. n1 = 500, n2 = 500, p1 = 0.25, and p2 = 0.25. 0.2 n 0 ) B ( x a m λ −0.2 0 0.05 0.1 0.15 1 0.8 0.6 y t i l i b a t c e t e d 0 0.05 0.1 0.15 i i y Tn 1 20 0 −20 0 0.05 0.1 0.15 (a) 0.2 p (b) 0.2 p (c) 0.2 p simulation p1p2−p2 cp1+2p+ p2 c 0.25 0.3 0.35 0.4 0.25 0.3 0.35 T y1 1n1 T y2 1n2 ±p n1n2 n 0.4 0.25 0.3 0.35 0.4 FIG. 6. n1 = 1000, n2 = 1000, p1 = 0.25, and p2 = 0.25. ) B ( x a m λ 0.2 n 0 −0.2 0 0.05 0.1 0.15 1 0.8 0.6 y t i l i b a t c e t e d 0 0.05 0.1 0.15 i i y Tn 1 40 20 0 −20 −40 0 0.05 0.1 0.15 (a) 0.2 p (b) 0.2 p (c) 0.2 p simulation p1p2−p2 cp1+2p+ p2 c 0.25 0.3 0.35 0.4 0.25 0.3 0.35 T y1 1n1 T y2 1n2 ±p n1n2 n 0.4 0.25 0.3 0.35 0.4 FIG. 7. n1 = 4000, n2 = 4000, p1 = 0.25, and p2 = 0.25.
1507.00925
1
1507
2015-06-17T12:49:34
Global clustering coefficient in scale-free weighted and unweighted networks
[ "cs.SI", "math.CO", "math.PR" ]
In this paper, we present a detailed analysis of the global clustering coefficient in scale-free graphs. Many observed real-world networks of diverse nature have a power-law degree distribution. Moreover, the observed degree distribution usually has an infinite variance. Therefore, we are especially interested in such degree distributions. In addition, we analyze the clustering coefficient for both weighted and unweighted graphs. There are two well-known definitions of the clustering coefficient of a graph: the global and the average local clustering coefficients. There are several models proposed in the literature for which the average local clustering coefficient tends to a positive constant as a graph grows. On the other hand, there are no models of scale-free networks with an infinite variance of the degree distribution and with an asymptotically constant global clustering coefficient. Models with constant global clustering and finite variance were also proposed. Therefore, in this paper we focus only on the most interesting case: we analyze the global clustering coefficient for graphs with an infinite variance of the degree distribution. For unweighted graphs, we prove that the global clustering coefficient tends to zero with high probability and we also estimate the largest possible clustering coefficient for such graphs. On the contrary, for weighted graphs, the constant global clustering coefficient can be obtained even for the case of an infinite variance of the degree distribution.
cs.SI
cs
Global clustering coefficient in scale-free weighted and unweighted networks Liudmila Ostroumova Prokhorenkova12 1 Yandex, Moscow, Russia 2 Moscow State University, Moscow, Russia Abstract. In this paper, we present a detailed analysis of the global clustering coefficient in scale-free graphs. Many observed real-world net- works of diverse nature have a power-law degree distribution. Moreover, the observed degree distribution usually has an infinite variance. There- fore, we are especially interested in such degree distributions. In addition, we analyze the clustering coefficient for both weighted and unweighted graphs. There are two well-known definitions of the clustering coefficient of a graph: the global and the average local clustering coefficients. There are several models proposed in the literature for which the average local clustering coefficient tends to a positive constant as a graph grows. On the other hand, there are no models of scale-free networks with an infinite variance of the degree distribution and with an asymptotically constant global clustering coefficient. Models with constant global clustering and finite variance were also proposed. Therefore, in this paper we focus only on the most interesting case: we analyze the global clustering coefficient for graphs with an infinite variance of the degree distribution. For unweighted graphs, we prove that the global clustering coefficient tends to zero with high probability and we also estimate the largest pos- sible clustering coefficient for such graphs. On the contrary, for weighted graphs, the constant global clustering coefficient can be obtained even for the case of an infinite variance of the degree distribution. 1 Introduction In this paper, we analyze the global clustering coefficient of graphs with a power-law degree distribution. Namely, we consider a sequence of graphs with degree distributions following a regularly varying distribution F . It was previ- ously shown in [9] that if a graph has a power-law degree distribution with an infinite variance, then the global clustering coefficient tends to zero with high probability. Namely, an upper bound for the number of triangles is obtained in [9]. In addition, the constructing procedure which allows to obtain the se- quence of graphs with a superlinear number of triangles is presented. However, the number of triangles in the constructed graphs grows slower than the upper bound obtained. In this paper, we close this gap by improving the upper bound obtained in [9]. Moreover, we also analyze graphs with multiple edges and show 5 1 0 2 n u J 7 1 ] I S . s c [ 1 v 5 2 9 0 0 . 7 0 5 1 : v i X r a 2 L. Ostroumova Prokhorenkova that weighted scale-free graphs with asymptotically constant global clustering coefficient and with an infinite variance of the degree distribution do exist. The rest of the paper is organized as follows. In the next section, we dis- cuss several definitions of the clustering coefficient for weighted and unweighted graphs. Then, in Section 3, we formally define our restriction on a sequence of graphs. In Sections 5 and 6, we analyze the global clustering coefficient for the unweighted and the weighted case respectively. Section 7 concludes the paper. 2 Clustering coefficients There are two well-known definitions of the clustering coefficient [2,5] of an unweighted graph. The global clustering coefficient C1(Gn) is the ratio of three times the number of triangles to the number of pairs of adjacent edges in Gn. The average local clustering coefficient is defined as follows: C2(Gn) = 1 i=1 C(i), where C(i) is the local clustering coefficient for a vertex i: C(i) = T i , where P i 2 T i is the number of edges between the neighbors of the vertex i and P i 2 is the number of pairs of neighbors. Note that both clustering coefficients equal 1 for a complete graph. nPn It was mentioned in [2,5] that in research papers either the average local or the global clustering coefficients are considered, and it is not always clear which definition is used. On the other hand, these two clustering coefficients differ: e.g., it was demonstrated in [7] that for networks based on the idea of preferential attachment the difference between these two clustering coefficients is crucial. It is also reasonable to study the global clustering coefficient for graphs with multiple edges. This agrees well with reality, for example, the Web host graph has a lot of multiple edges: there can be several edges between the pages of two hosts. And even in the Internet graph (vertices are web pages and edges are links between them) multiple edges occur. We refer to the paper [6] for the definition of the global clustering coefficient for weighted graphs. They propose the following generalization of the global clustering coefficient to multigraphs: C1(G) = total value of closed triplets total value of triplets . There are several ways to define the value of a triplet. First, the triplet value can be defined as the arithmetic mean of the weights of the ties that make up the triplet. Second, it can be defined as the geometric mean of the weights of the ties. Third, it can be defined as the maximum or minimum value of the weights of the ties. In addition to these methods proposed in [6], we also propose the following natural definition of the weight: the weight of a triplet is the product of the weights of the ties. This definition agrees with the following property: the total value of all triplets located in a vertex is close to its degree squared. Global clustering coefficient in scale-free networks 3 3 Scale-free graphs We consider a sequence of graphs {Gn}. Each graph Gn has n vertices. As in [9], we assume that the degrees of the vertices are independent random variables following a regularly varying distribution with a cumulative distribution function F satisfying 1 − F (x) = L(x)x−γ, x > 0, (1) where L(·) is a slowly varying function, that is, for any fixed constant t > 0 L(tx) L(x) lim x→∞ = 1. There is another obvious restriction on the function L(·): the function 1 − L(x)x−γ must be a cumulative distribution function of a random variable taking positive integer values with probability 1. Note that Equation (1) describes a broad class of heavy-tailed distributions without imposing the rigid Pareto assumption. The power-law distribution with parameter γ + 1 corresponds to the cumulative distribution 1− F (x) = L(x)x−γ . Further by ξ, ξ1, ξ2, . . . we denote random variables with the distribution F . Note that for any α < γ the moment Eξα is finite. Models with γ > 2 and with the global clustering coefficient tending to some positive constant were already proposed (see, e.g., [7]). Therefore, in this paper we consider only the case 1 < γ < 2. One small problem remains: we can construct a graph with a given degree distribution only if the sum of all degrees is even. This problem is easy to solve: we can either regenerate the degrees until their sum is even or we can add 1 to the last variable if their sum is odd [3]. For the sake of simplicity we choose the i=1 ξi is odd, then we replace ξn by ξn + 1. It is easy to see that this modification does not change any of our results, therefore, further we do not focus on the evenness. second option, i.e., if Pn 4 Auxiliary results In this section, we prove several auxiliary lemmas. These lemmas generalize several results from [9]. In order to prove these lemmas we use the following theorem (see, e.g., [1]). Theorem 1 (Karamata's theorem) Let L be slowly varying and locally bounded in [x0,∞] for some x0 ≥ 0. Then 1. for α > −1 Z x tαL(t)dt = (1 + o(1))(α + 1)−1xα+1L(x), x → ∞ . x0 4 L. Ostroumova Prokhorenkova 2. for α < −1 Z ∞ x tαL(t)dt = −(1 + o(1))(α + 1)−1xα+1L(x), x → ∞ . We also use the following known lemma (its proof can be found, e.g., in [8]). Lemma 1 Let ξ1, . . . , ξn be mutually independent random variables, Eξi = 0, Eξiα < ∞, 1 ≤ α ≤ 2, then E (ξ1 + . . . + ξnα) ≤ 2α (E (ξ1α) + . . . + E (ξnα)) . We need the following notation: n Sn,c(x) = ¯Sn,c(x) = ξc i I [ξi > x] , ξc i I [ξi ≤ x] , Xi=1 Xi=1 n here c, x ≥ 0. Lemma 2 Fix any c such that 0 ≤ c < γ, any β such that 1 < β < γ/c and β ≤ 2, and any ε > 0. Then for any x = x(n) > 0 such that x(n) → ∞ we have ESn,c(x) = γ γ − c n xc−γL (x) (1 + o(1)), n → ∞ , P (Sn,c(x) − ESn,c(x) > ε ESn,c(x)) = O (cid:18) xγ n L (x)(cid:19)β−1! . Proof. We now assume that c > 0. First, we estimate the expectation of Sn,c(x): ESn,c(x) = nZ ∞ x x ∞ tcdF (t) = −nZ ∞ tc d(1 − F (t)) + n cZ ∞ = −n tc(1 − F (t))(cid:12)(cid:12)(cid:12)(cid:12) = n xc−γL (x) + n cZ ∞ x x x tc−1(1 − F (t)) dt tc−1−γL(t) dt ∼ n xc−γL (x) − n c(c − γ)−1xc−γL (x) = n xc−γL (x) . γ γ − c Then, we estimate E (ξcI [ξ > x])β = 1 n ESn,cβ(x) ∼ γ γ − βc xβc−γL (x) Global clustering coefficient in scale-free networks 5 and get P (Sn,c(x) − ESn,c(x) > ε ESn,c(x)) ≤ = O nE (ξcI [ξ > x])β (ε ESn,c(x))β ESn,c(x) − ESn,c(x)β nβxβ(c−γ) (L (x))β! (ESn,c(x))β ! = O n xβc−γL (x) = O(cid:16)n1−βx−(1−β)γ (L (x))1−β(cid:17) . The case c = 0 can be considered similarly: ESn,0(x) = nP(ξ > x) = n x−γL (x) , P (Sn,0(x) − ESn,0(x) > ε ESn,0(x)) = O(cid:18) nx−γL (x) (n x−γL (x))β(cid:19) = O (cid:18) xγ n L (x)(cid:19)β−1! . Lemma 3 Fix any c such that c > γ and any ε > 0. Then for any x = x(n) > 0 such that x(n) → ∞ we have γ c − γ E ¯Sn,c(x) = n xc−γL (x) (1 + o(1)), n → ∞ , P(cid:0) ¯Sn,c(x) − E ¯Sn,c(x) > ε E ¯Sn,c(x)(cid:1) = O(cid:18) xγ n L (x)(cid:19) . Proof. Again, first we estimate the expectation of ¯Sn,c(x): E ¯Sn,c(x) = nZ x 0 x tcdF (t) = −nZ x tc d(1 − F (t)) + n cZ x = −n tc(1 − F (t))(cid:12)(cid:12)(cid:12)(cid:12) = −n xc−γL (x) + n cZ x 0 0 0 0 tc−1(1 − F (t)) dt tc−1−γL(t) dt ∼ −n xc−γL (x) + n c(c − γ)−1xc−γL (x) = n xc−γL (x) . γ c − γ Then, we estimate E (ξcI [ξ ≤ x])2 = 1 n ¯Sn,2c(x) ∼ γ 2c − γ x2c−γL (x) and get P(cid:0) ¯Sn,c(x) − E ¯Sn,c(x) > ε E ¯Sn,c(x)(cid:1) ≤ = O nE (ξcI [ξ ≤ x])2 (E ¯Sn,c(x))2 ! = O n x2c−γL (x) (ε E ¯Sn,c(x))2 E ¯Sn,c(x) − E ¯Sn,c(x)2 n2x2(c−γ) (L (x))2! = O(cid:18) xγ n L (x)(cid:19) . 6 L. Ostroumova Prokhorenkova We prove two more lemmas. Put ξmax = max{ξ1, . . . , ξn}. Lemma 4 For any ε > 0 and any α > 0 Also, for any δ < γε Proof. P(cid:16)ξmax ≤ n P(ξmax > n 1 1 1 γ −ε(cid:17) = 1 − O(cid:0)n−α(cid:1) . P(cid:16)ξmax > n P(cid:16)ξmax ≤ n γ +ε(cid:17) = 1 − O(cid:0)n−δ(cid:1) . γ −ε(cid:17)in γ −ε(cid:17) =hP(cid:16)ξ ≤ n = exp(cid:16)n log(cid:16)1 − L(cid:16)n = exp(cid:16)−n L(cid:16)n γ −ε(cid:17) n−γ( 1 = exp(cid:16)−L(cid:16)n 1 1 1 1 γ −ε)(cid:17)(cid:17) = exp(cid:16)n log(cid:16)1 − P(ξ > n γ −ε(cid:17) n−γ( 1 γ −ε)(cid:17)(cid:17) γ −ε)(1 + o(1))(cid:17) γ −ε(cid:17) nγε(1 + o(1))(cid:17) = O(cid:0)n−α(cid:1) , γ +ε) = O(cid:0)n−δ(cid:1) . 1 1 Proof. Choose ϕ such that δ γ < ϕ < ε γ+2 . From Lemma 4 we get 1 2 γ +ε(cid:17) n−γ( 1 γ +ε(cid:17) ≤ n L(cid:16)n γ +ε(cid:17) = 1 − O(cid:0)n−δ(cid:1) . γ +ϕ) = 1 − O(cid:0)n−δ(cid:1) .   = 1 − O(cid:0)n−δ(cid:1) γ +ϕγ−2ϕL(cid:16)n γ −ϕ(cid:17) . γ −ϕ(cid:17) 2 − γ γ −ϕ) n γ 1 2 1 γ −ϕ(cid:17) , Lemma 5 For any ε > 0 and any δ < γε γ+2 1 1 γ +ε) ≤ n P(cid:16)ξ > n P(cid:16) ¯Sn,2(∞) ≤ n P(ξmax ≤ n From Lemma 2 and Lemma 3, with probability we have nγ( 1 1 − O  1 1 ¯Sn,2(cid:16)n n L(cid:16)n γ −ϕ(cid:17) ≤ (1 + ε) Sn,0(cid:16)n γ +ϕ(cid:17) ≤ ¯Sn,2(cid:16)n 2 − γ γ +ϕγ−2ϕL(cid:16)n n γ 2 In this case, 1 ¯Sn,2(cid:16)n ≤ (1 + ε) 1 γ −ϕ(cid:17) ≤ (1 + ε) nϕγL(cid:16)n γ −ϕ(cid:17) + ξmax Sn,0(cid:16)n γ −ϕ(cid:17) 1 1 2 1 γ −ϕ(cid:17) + n γ +2ϕ(1 + ε) nϕγL(cid:16)n 2 γ +ε 1 γ −ϕ(cid:17) ≤ n for large enough n. This concludes the proof. Note that we estimated only the upper bound for ¯Sn,2(∞), since the lower bound can be obtained using the lower bound for ξmax. Here we may use the inequality Sn,2(∞) ≥ ξ2 max. Global clustering coefficient in scale-free networks 7 5 Clustering in unweighted graphs 5.1 Previous results The behavior of the global clustering coefficient in scale-free unweighted graphs was considered in [9]. In the case of an infinite variance, the reasonable question is whether there exists a simple graph (i.e., a graph without loops and multiple edges) with a given degree distribution. The following theorem is proved in [9]. Theorem 2 With hight probability there exists a simple graph on n vertices with the degree distribution defined in Section 3. So, with high probability such a graph exists and it is reasonable to discuss its global clustering coefficient. The following upper bound on the global clustering coefficient is obtained in [9]. Theorem 3 For any ε > 0 with high probability the global clustering coefficient satisfies the following inequality C1(Gn) ≤ n− (γ−2)2 2γ +ε . Taking small enough ε one can see that with high probability C1(Gn) → 0 as n grows. In addition, using simulations and empirical observations, the authors of [9] 3 γ+1 triangles claimed that with high probability there exists a graph with ∼ n and with the required degree distribution, while the theoretical upper bound on the number of triangles is n2− γ 2 . For the considered case 1 < γ < 2 we have γ+1 < 2− γ 2 and there is a gap between the number of constructed triangles and the obtained upper bound. 3 Further in this section we close this gap by improving the upper bound. We also rigorously prove the lower bound. 5.2 Upper bound We prove the following theorem. Theorem 4 For any ε > 0 and any α such that 0 < α < 1 1 − O(n−α) the global clustering coefficient satisfies the following inequality γ+1 with probability Proof. The global clustering coefficient is C1(Gn) ≤ n− (2−γ) γ(γ+1) +ε . C1(Gn) = 3 · T (n) P2(n) , where T (n) is the number of triangles and P2(n) is the number of pairs of adjacent edges in Gn. 8 L. Ostroumova Prokhorenkova Since P2(n) ≥ ξmax(ξmax − 1)/2. Therefore, from Lemma 4 we get that for any δ > 0 with probability 1 − O (n−α) P2(n) > n 2 γ −δ . It remains to estimate T (n). Obviously, for any x T (n) ≤ {i : ξi > x}3 + Xi:ξi≤x ξ2 i . (2) The first term in (2) is the upper bound for the number of triangles with all vertices among the set {i : ξi > x}. The second term is the upper bound for the number of triangles with at least one vertex among {i : ξi ≤ x}. From Lemma 2 and Lemma 3 we get {i : ξi > x} = Sn,0(x) ≤ (1 + ε)n x−γL (x) , Xi:ξi≤x n x2−γL (x) 2 − γ γ i = ¯Sn,2(x) ≤ (1 + ε) ξ2 n L(x)(cid:17) . with probability 1 − O(cid:16) xγ 1 − O  Now we can fix x = n n− 1 γ+1 1 γ+1 . So, with probability we have   = 1 − O(n−α) 3 γ+1 +δ 1 γ+1(cid:17) L(cid:16)n T (n) ≤ n Taking small enough δ, we obtain C1(Gn) ≤ nε− 2−γ γ(γ+1) . This concludes the proof. 5.3 Lower bound We prove the following theorem. Theorem 5 For any ε > 0 and any α such that 0 < α < min{ γε γ+1 , γ − 1} γ+2 , with probability 1 − O(n−α) there exists a graph with the required degree distri- bution and the global clustering coefficient satisfying the following inequality 1 C1(Gn) ≥ n− (2−γ) γ(γ+1) −ε . Global clustering coefficient in scale-free networks 9 Proof. Again, C1(Gn) = 3 · T (n) P2(n) . The upper bound for P2(n) follows from Lemma 5. Fix ε′ such that α(γ+2) γ < ε′ < ε. Then, 2 γ +ε′(cid:17) ≥ P(cid:16) ¯Sn,2(∞) ≤ n 2 γ +ε′(cid:17) = 1 − O(cid:0)n−α(cid:1) . Now we present the lower bound for T (n). Fix any δ such that 0 < γδ < P(cid:16)P2(n) ≤ n γ+1 − α, ε−ε′ Sn,0(cid:16)n 1 minn 1 3 o. It follows from Lemma 2 that with probability 1−O (n−α) γ+1 +δ(cid:17) ≤ (1 + ε) n γ+1 +δ(cid:17) ≤ n γ+1−γδL(cid:16)n γ+1 +δ . 1 1 1 Let us denote by A the set of vertices whose degrees are greater than n 1 size of A equals Sn,0(cid:16)n than the minimum degree in A, a clique on A can be constructed. Therefore, with probability 1 − O (n−α) γ+1 +δ(cid:17). Since the number of vertices in A is not greater 1 γ+1 +δ. The 1 1 Sn,0(cid:16)n 3T (n) ≥ 3(cid:18)Sn,0(cid:16)n γ+1 +δ(cid:17) ≥ (1 − ε) n γ+1 +δ(cid:17) γ+1−γδL(cid:16)n (cid:19) ≥ n 3 1 3 1 γ+1 +δ(cid:17) γ+1−(ε−ε′) . and Finally, we get C1(Gn) = 3 · T (n) P2(n) ≥ 3 γ+1−(ε−ε′) n 2 γ +ε′ n = n− (2−γ) γ(γ+1) −ε . It remains to prove that after we constructed a clique on the set A, with high probability we still can construct a graph without loops and multiple edges. This can be easily proved similarly to Theorem 2. Namely, we use the following theorem by Erdos and Gallai [4]. Theorem 6 (Erdos -- Gallai) A sequence of non-negative integers d1 ≥ . . . ≥ dn can be represented as the degree sequence of a finite simple graph on n vertices if and only if 1. d1 + . . . + dn is even; i=1 di ≤ k(k − 1) +Pn 2. Pk Let us order the random variables ξ1, . . . , ξn and obtain the ordered sequence d1 ≥ . . . ≥ dn. In order to apply the theorem of Erdos and Gallai we assume that the set A is now a single vertex with the degree i=k+1 min(di, k) holds for 1 ≤ k ≤ n. deg(A) = Sn,1(cid:16)n 1 γ+1 +δ(cid:17) − 2(cid:18)Sn,0(cid:16)n 2 1 γ+1 +δ(cid:17) (cid:19) < Sn,1(cid:16)n 1 γ+1 +δ(cid:17) . 10 L. Ostroumova Prokhorenkova It is sufficient to prove that with probability 1 − O(n−α) the following con- dition is satisfied deg(A) + k Xi=A+1 di ≤ (k − A)(k − A + 1) + n Xi=k+1 min(di, k − A + 1) (3) for all k ≥ A. For some large enough C if k > C√n, then Let us now prove that with probability 1− O(n−α) this condition is satisfied. deg(A) + k Xi=A+1 di ≤ (k − A)(k − A + 1) . This holds since with probability 1 − O(n−α) γ+1 +δ(cid:17) ≤ (1 + ε)n A = Sn,0(cid:16)n 1 and the sum of all degrees grows linearly with n: 1 γ+1−δL(cid:16)n 1 γ+1 +δ(cid:17) ≤ n 1 γ+1 . P(cid:16)Sn,1(0) − nEξ > n 2 Eξ(cid:17) ≤ 4α+1n Eξ − Eξα+1 nα+1(Eξ)α+1 = O(cid:0)n−α(cid:1) . Here we used that α + 1 < γ. Finally, consider the case k ≤ C√n. Note that min(di, k − A + 1) > 1, so n Xi=k+1 min(di, k − A + 1) ≥ n − C√n . It remains to show that with probability 1 − O(n−α) di ≤ n − C√n . deg(A) + k Xi=A+1 It is sufficient to show that [C√n] Xi=1 di ≤ n − C√n . This inequality is easy to prove using Lemma 2. For any 1 3γ < δ < 1 2γ with probability 1 − O(cid:0)n−1/2(cid:1) we have and Therefore, the condition (3) is satisfied. Sn,0(cid:0)nδ(cid:1) > C√n Sn,1(cid:0)nδ(cid:1) ≤ n 2γ+1 3γ ≤ n − C√n . Global clustering coefficient in scale-free networks 11 6 Clustering in weighted graphs In this section, we analyze the global clustering coefficient of graphs with multi- ple edges. First, let us note that the case when we allow both loops and multiple edges is not very interesting: we can get a high clustering coefficient just by avoiding triplets. Namely, we can construct several triangles and then just cre- ate loops in all vertices. Then, we can connect the remaining half-edges for the vertices with odd degrees. Therefore, further we assume that loops are not al- lowed. We show that even with this restriction it is possible to obtain a constant global clustering coefficient. Several definitions of the global clustering coefficient for graphs with multiple edges are presented in Section 2. The following theorem holds for any definition of the global clustering coefficient C1(Gn). Theorem 7 Fix any δ > 0. For any α such that 0 < α < γ−1 γ+1 with probability 1 − O (n−α) there exists a multigraph with the required degree distribution and the global clustering coefficient satisfying the following inequality C1(Gn) ≥ 2 − γ 2 + γ − δ . Proof. Fix some ε > 0. From Lemma 2 with c = 0 it follows that with probability 1 − O(cid:16) xγ n L(x)(cid:17) (1 − ε) n x−γL (x) ≤ Sn,0(x) ≤ (1 + ε) n x−γL (x) . Let us prove that for large enough n there always exists such x0 that (1 + ε) n x−γ 0 L (x0) ≤ x0 ≤ (1 + 2ε) n x−γ 0 L (x0) . In other words, we want to find such x0 that 1 (1 + 2ε) n ≤ x−γ 0 L (x0) x0 ≤ 1 (1 + ε) n . (4) (5) Recall that x−γL (x) = 1 − F (x), where F (x) is a cumulative distribution func- tion. Therefore, f (x) = x−γ L(x) monotonically decreases to zero on (0,∞). The only problem is that f (x) is a discontinuous function. In order to guarantee the existence of the required value x0, we have to prove that (for large enough n) if f (x) < 1 (1+ε)(1+2ε)n . This can be proved as follows. For the function F (x) it is obvious that if 1− F (x) < 1 n , then F (x+)− F (x−) < 1 n . Therefore, in this case, f (x+) − f (x−) < 1 x n . For large enough n (and this leads to large enough x) we have 1 ε (1+ε)(1+2ε)n . This concludes the proof of the fact that the required x0 exists. n , then f (x+)−f (x−) < x n ≤ x ε We take any value that satisfies Equation (5) and further denote it by x0. γ+1 . Therefore, Note that, up to a slowly varying multiplier, x0 is of order n 1 12 L. Ostroumova Prokhorenkova 0 O(cid:16) xγ bility 1 − O(cid:16) xγ n L(x0)(cid:17) = O (n−α). From Equations (4) and (5) it follows that with proba- n L(x0)(cid:17) the number of vertices with degree greater than x0 (i.e., Sn,0(x0)) is not larger than x0. Denote this set of vertices by Ax0. In this case, a clique on Ax0 can be constructed. 0 In addition, we want all vertices from the set Ax0 to be connected only to each other. This can be possible, since multiple edges are allowed. If the sum of degrees in Ax0 is odd, then we allow one edge (from the vertex with the smallest degree in Ax0 ) to go outside this set. We are ready to estimate the global clustering coefficient: C1(Gn) = total value of closed triplets total value of triplets . The total value of closed triplets is at least 3(cid:0)Sn,0(x0) of the value of a triplet. With probability 1 − O(cid:16) xγ (1 − ε)3 n3 x−3γ 1 2 3(cid:18)Sn,0(x0) (cid:19) ≥ 3 3 0 L3 (x0) . (cid:1) regardless of the definition n L(x0)(cid:17) 0 The total value of all triplets includes: -- The total value of closed triplets on Ax0 estimated above, -- The total value of triplets on the remaining vertices, which is not greater than ¯Sn,2(x0), -- (optionally) Some unclosed triplets on the vertex with the smallest degree in Ax0 , if the sum of degrees in Ax0 is odd. Since the smallest degree in the set Ax0 is of order x0, we can estimate the last two summands in the total value of triplets by ¯Sn,2(x0) + O(cid:0)x2 0(cid:1) ≤ (1 + ε) γ 2 − γ n x2−γ 0 L (x0) . By Lemma 3, this holds with probability 1 − O(cid:16) xγ Finally, with probability 1 − O(cid:16) xγ n L(x0)(cid:17) we have C1(Gn) ≥ 2 (1 − ε)3 n3 x−3γ 0 L3 (x) 0 L3 (x0) + (1 + ε) γ 2 (1 − ε)3 n3 x−3γ 1 1 0 0 n L(x0)(cid:17). 2−γ n x2−γ 0 L (x0) ≥ 1 2 (1 − ε)3 n2 x−2γ 1 2 (1 − ε)3 n2 x−2γ 0 L2 (x0) + (1 + ε) γ 0 L2 (x0) 2−γ (1 + 2ε)2 n2 x−2γ 2 (1 − ε)3 2−γ (1 + 2ε)2 ≥ 2 (1 − ε)3 + (1 + ε) γ = 1 1 0 L2 (x0) 2 − γ 2 + γ − δ . for sufficiently small ε. Here in the second inequality we used Equation 5. Global clustering coefficient in scale-free networks 13 Recall that the loops are not allowed. Therefore, it remains to prove that 1) a multi-clique on Ax0 can be constructed; 2) a graph on the remaining vertices can be constructed. Note that a multigraph without loops can always be constructed if the maximum degree is not larger than the sum of the other degrees. A multi-clique on Ax0 can be constructed if ξmax ≤ Sn,1(x0) − ξmax − x2 0. (6) 0 is the upper bound for the number of half-edges already involved in the Here x2 required clique. From Lemma 2, with probability 1 − O (n−α) Sn,1(x0) > (1 − ε) γ n x1−γ 0 L (xo) . (7) γ − 1 γ+1 − α(cid:17). In this case we have α < γ (cid:16) γ−1 Fix some ε′ such that 0 < ε′ < 1 γ−1 γ+1 − ε′γ, therefore Lemma 4 gives that γ+1−ε′(cid:17) = P(cid:16)ξmax ≤ n γ(γ+1)−ε′(cid:17) = 1 − O(cid:0)n−α(cid:1) . P(cid:16)ξmax ≤ n γ + γ−1 Now Equation (6) follows immediately from (7), (8), and the fact that x0 is of order n 1 γ+1 . (8) Similarly, it is easy to show that the graph on the remaining vertices can be 2 1 constructed: since ¯Sn,1(x0) = Sn,1(0) − Sn,1(x0) grows linearly with n. x0 ≤ ¯Sn,1(x0) − x0 7 Conclusion In this paper, we fully analyzed the behavior of the global clustering coeffi- cient in scale-free graphs with an infinite variance of the degree distribution. We considered both unweighted graphs and graphs with multiple edges. For the unweighted case, we first obtained the upper bound for the global clustering co- efficient. In particular, we proved that the global clustering coefficient tends to zero with high probability. We also presented the constructing procedure which allows to reach the obtained upper bound. The situation turns out to be different for graphs with multiple edges. In this case, it is possible to construct a sequence of graphs with an asymptotically constant clustering coefficient. References 1. N.H. Bingham, C.M. Goldie, and J.L. Teugels, Regular Variation, Cambridge Uni- versity Press, Cambridge (1987) 2. B. Bollob´as, O.M. Riordan, Mathematical results on scale-free random graphs, Handbook of Graphs and Networks: From the Genome to the Internet, pp. 1- 3 (2003) 14 L. Ostroumova Prokhorenkova 3. T. Britton, M. Deijfen, and A. Martin-Lof, Generating simple random graphs with prescribed degree distribution, J. Stat. Phys., 124(6), pp. 1377-1397 (2006). 4. P. Erdos and T. Gallai, Graphs with given degrees of vertices, Mat. Lapok, 11, pp. 264-274 (1960). 5. M. E. J. Newman, The structure and function of complex networks, SIAM Review, vol. 45, pp. 167256 (2003). 6. T. Opsahl, P. Panzarasa, Clustering in weighted networks, Social Networks, 31(2), pp/ 155-163 (2009). 7. L. Ostroumova, A. Ryabchenko, E. Samosvat, Generalized Preferential Attach- ment: Tunable Power-Law Degree Distribution and Clustering Coefficient, Algo- rithms and Models for the Web Graph, Lecture Notes in Computer Science, vol. 8305, pp. 185 -- 202 (2013). 8. L. Ostroumova, E. Samosvat, Recency-based preferential attachment models, http://arxiv.org/abs/1406.4308 (2014). 9. L. Ostroumova Prokhorenkova, E. Samosvat, Global Clustering Coefficient in Scale-free networks, Volume 8882 of the Lecture Notes in Computer Science se- ries, pp. 47 -- 58 2014.
1109.3911
1
1109
2011-09-18T21:14:15
Benefits of Bias: Towards Better Characterization of Network Sampling
[ "cs.SI", "physics.soc-ph" ]
From social networks to P2P systems, network sampling arises in many settings. We present a detailed study on the nature of biases in network sampling strategies to shed light on how best to sample from networks. We investigate connections between specific biases and various measures of structural representativeness. We show that certain biases are, in fact, beneficial for many applications, as they "push" the sampling process towards inclusion of desired properties. Finally, we describe how these sampling biases can be exploited in several, real-world applications including disease outbreak detection and market research.
cs.SI
cs
Towards Better Characterization of Network Sampling Benefits of Bias: Arun S. Maiya Dept. of Computer Science University of Illinois at Chicago [email protected] Tanya Y. Berger-Wolf Dept. of Computer Science University of Illinois at Chicago [email protected] 1 1 0 2 p e S 8 1 ] I S . s c [ 1 v 1 1 9 3 . 9 0 1 1 : v i X r a ABSTRACT From social networks to P2P systems, network sampling arises in many settings. We present a detailed study on the nature of biases in network sampling strategies to shed light on how best to sample from networks. We investigate connections between specific biases and various measures of structural representativeness. We show that certain biases are, in fact, beneficial for many applications, as they “push” the sampling process towards inclusion of desired properties. Finally, we describe how these sampling biases can be ex- ploited in several, real-world applications including disease outbreak detection and market research. Categories and Subject Descriptors H.2.8 [Database Management]: Database Applications— Data Mining General Terms Algorithms; Experimentation, Measurement Keywords sampling, bias, social network analysis, complex networks, graph mining, link mining, online sampling, crawling 1. INTRODUCTION AND MOTIVATION We present a detailed study on the nature of biases in net- work sampling strategies to shed light on how best to sample from networks. A network is a system of interconnected en- tities typically represented mathematically as a graph: a set of vertices and a set of edges among the vertices. Networks are ubiquitous and arise across numerous and diverse do- mains. For instance, many Web-based social media, such as online social networks, produce large amounts of data on interactions and associations among individuals. Mobile phones and location-aware devices produce copious amounts of data on both communication patterns and physical prox- imity between people. In the domain of biology also, from Permission to make digital or hard copies of all or part of this work for personal or classroom use is granted without fee provided that copies are not made or distributed for profit or commercial advantage and that copies bear this notice and the full citation on the first page. To copy otherwise, to republish, to post on servers or to redistribute to lists, requires prior specific permission and/or a fee. KDD’11, August 21–24, 2011, San Diego, California, USA. Copyright 2011 ACM 978-1-4503-0813-7/11/08 ...$10.00. neurons to proteins to food webs, there is now access to large networks of associations among various entities and a need to analyze and understand these data. With advances in technology, pervasive use of the Internet, and the proliferation of mobile phones and location-aware devices, networks under study today are not only substan- tially larger than those in the past, but sometimes exist in a decentralized form (e.g. the network of blogs or the Web itself). For many networks, their global structure is not fully visible to the public and can only be accessed through “crawls” (e.g. online social networks). These factors can make it prohibitive to analyze or even access these networks in their entirety. How, then, should one proceed in analyzing and mining these network data? One approach to address- ing these issues is sampling: inference using small subsets of nodes and links from a network. From epidemiological applications [13] to Web crawling [7] and P2P search [47], network sampling arises across many different settings. In the present work, we focus on a partic- ular line of investigation that is concerned with constructing samples that match critical structural properties of the orig- inal network. Such samples have numerous applications in data mining and information retrieval. In [29], for example, structurally-representative samples were shown to be effec- tive in inferring network protocol performance in the larger network and significantly improving the efficiency of proto- col simulations. In Section 7, we discuss several additional applications. Although there have been a number of re- cent strides in work on network sampling (e.g. [3,25,29,34]), there is still very much that requires better and deeper un- derstanding. Moreover, many networks under analysis, al- though treated as complete, are, in fact, samples due to lim- itations in data collection processes. Thus, a more refined understanding of network sampling is of general importance to network science. Towards this end, we conduct a detailed study on network sampling biases. There has been a recent spate of work focusing on problems that arise from network sampling biases including how and why biases should be avoided [1, 15, 20, 30, 46, 47]. Our work differs from much of this existing literature in that, for the first time in a compre- hensive manner, we examine network sampling bias as an as- set to be exploited. We argue that biases of certain sampling strategies can be advantageous if they “push” the sampling process towards inclusion of specific properties of interest.1 Our main aim in the present work is to identify and under- stand the connections between specific sampling biases and 1This is similar to the role of bias in stratified sampling in classical statistics. specific definitions of structural representativeness, so that these biases can be leveraged in practical applications. Summary of Findings. We conduct a detailed investiga- tion of network sampling biases. We find that bias towards high expansion (a concept from expander graphs) offers sev- eral unique advantages over other biases such as those to- ward high degree nodes. We show both empirically and an- alytically that such an expansion bias “pushes” the sampling process towards new, undiscovered clusters and the discov- ery of wider portions of the network. In other analyses, we show that a simple sampling process that selects nodes with many connections from those already sampled is often a reasonably good approximation to directly sampling high degree nodes and locates well-connected (i.e. high degree) nodes significantly faster than most other methods. We also find that the breadth-first search, a widely-used sampling and search strategy, is surprisingly among the most dismal performers in terms of both discovering the network and accumulating critical, well-connected nodes. Finally, we de- scribe ways in which some of our findings can be exploited in several important applications including disease outbreak detection and market research. A number of these afore- mentioned findings are surprising in that they are in stark contrast to conventional wisdom followed in much of the ex- isting literature (e.g. [2, 13, 30, 41, 42]). 2. RELATED WORK Not surprisingly, network sampling arises across many di- verse areas. Here, we briefly describe some of these different lines of research. Network Sampling in Classical Statistics. The concept of sampling networks first arose to address scenarios where one needed to study hidden or difficult-to-access populations (e.g. illegal drug users, prostitutes). For recent surveys, one might refer to [19, 28]. The work in this area focuses almost exclusively on acquiring unbiased estimates related to vari- ables of interest attached to each network node. The present work, however, focuses on inferring properties related to the network itself (many of which are not amenable to being fully captured by simple attribute frequencies). Our work, then, is much more closely related to representative subgraph sampling. Representative Subgraph Sampling. In recent years, a number of works have focused on representative subgraph sampling: constructing samples in such a way that they are condensed representations of the original network (e.g. [3, 25, 29, 32, 34]). Much of this work focuses on how best to produce a “universal” sample representative of all structural properties in the original network. By contrast, we subscribe to the view that no single sampling strategy may be appro- priate for all applications. Thus, our aim, then, is to better understand the biases in specific sampling strategies to shed light on how best to leverage them in practical applications. Unbiased Sampling. There has been a relatively recent spate of work (e.g. [20, 22, 47]) that focuses on constructing uniform random samples in scenarios where nodes cannot be easily drawn randomly (e.g. settings such as the Web where nodes can only be accessed through crawls). These strategies, often based on modified random walks, have been shown to be effective for various frequency estimation prob- lems (e.g. inferring the proportion of pages of a certain lan- guage in a Web graph [22]). However, as mentioned above, the present work focuses on using samples to infer structural (and functional) properties of the network itself. In this re- gard, we found these unbiased methods to be less effective during preliminary testing. Thus, we do not consider them and instead focus our attention on other more appropriate sampling strategies (such as those mentioned in representa- tive subgraph sampling). Studies on Sampling Bias. Several studies have inves- tigated biases that arise from various sampling strategies (e.g. [1, 15, 30, 31, 46]). For instance, [46] showed that, un- der the simple sampling strategy of picking nodes at ran- dom from a scale-free network (i.e. a network whose degree distribution follows the power law), the resultant subgraph sample will not be scale-free. The authors of [1, 31] showed the converse is true under traceroute sampling. Virtually all existing results on network sampling bias focus on its neg- ative aspects. By contrast, we focus on the advantages of certain biases and ways in which they can be exploited in network analysis. Property Testing. Work on sampling exists in the fields of combinatorics and graph theory and is centered on the notion of property testing in graphs [38]. Properties such as those typically studied in graph theory, however, may be less useful for the analysis of real-world networks (e.g. the exact meaning of, say, k-colorability [38] within the context of a social network is unclear). Nevertheless, theoretical work on property testing in graphs is excellently surveyed in [38]. Other Areas. Decentralized search (e.g. searching un- structured P2P networks) and Web crawling can both be framed as network sampling problems, as both involve mak- ing decisions from subsets of nodes and links from a larger network. Indeed, network sampling itself can be viewed as a problem of information retrieval, as the aim is to seek out a subset of nodes that either individually or collectively match some criteria of interest. Several of the sampling strategies we study in the present work, in fact, are graph search al- gorithms (e.g. breadth-first search). Thus, a number of our findings discussed later have implications for these research areas (e.g. see [39]). For reviews on decentralized search both in the contexts of complex networks and P2P systems, one may refer to [27] and [49], respectively. For examples of connections between Web crawling and network sampling, see [7, 9, 42]. 3. PRELIMINARIES 3.1 Notations and Definitions We now briefly describe some notations and definitions used throughout this paper. Definition 1. G = (V, E) is a network or graph where V is set of vertices and E ⊆ V × V is a set of edges. Definition 2. A sample S is a subset of vertices, S ⊂ V . Definition 3. N (S) is the neighborhood of S if N (S) = {w ∈ V − S : ∃v ∈ S s.t. (v, w) ∈ E}. Definition 4. GS is the induced subgraph of G based on the sample S if GS = (S, ES) where the vertex set is S ⊂ V and the edge set is ES = (S × S) ∩ E. The induced subgraph of a sample may also be referred to as a subgraph sample. 3.2 Datasets We study sampling biases in a total of twelve different net- works: a power grid (PowerGrid [50]), a Wikipedia voting network (WikiVote [33]), a PGP trust network (PGP [6]), a citation network (HEPTh [33]), an email network (En- ron [33]), two co-authorship networks (CondMat [33] and AstroPh [33]), two P2P file-sharing networks (Gnutella04 [33] and Gnutella31 [33]), two online social networks (Epin- ions [33] and Slashdot [33] ), and a product co-purchasing network (Amazon [33]). These datasets were chosen to rep- resent a rich set of diverse networks from different domains. This diversity allows a more comprehensive study of net- work sampling and thorough assessment of the performance of various sampling strategies in the face of varying network topologies. Table 1 shows characteristics of each dataset. All networks are treated as undirected and unweighted. Network PowerGrid WikiVote PGP Gnutella04 AstroPh CondMat HEPTh Enron Gnutella31 Epinions Slashdot Amazon N 4941 7066 10,680 10,876 17,903 21,363 27,400 33,696 62,561 75,877 82,168 262,111 D 0.0005 0.004 0.0004 0.0006 0.0012 0.0004 0.0009 0.0003 0.00008 0.0001 0.0001 0.00003 PL CC AD 2.7 19 28.5 3.3 4.6 7.5 4.6 7.4 22.0 4.2 8.5 5.4 25.7 4.3 10.7 4.0 4.7 5.9 4.3 10.7 12.2 4.1 8.8 6.9 0.11 0.21 0.44 0.01 0.67 0.70 0.34 0.71 0.01 0.26 0.10 0.43 Table 1: Network Properties. Key: N= # of nodes, D= density, PL = characteristic path length, CC = local clus- tering coefficient, AD = average degree. 4. NETWORK SAMPLING In the present work, we focus on a particular class of sam- pling strategies, which we refer to as link-trace sampling. In link-trace sampling, the next node selected for inclusion into the sample is always chosen from among the set of nodes directly connected to those already sampled. In this way, sampling proceeds by tracing or following links in the net- work. This concept can be defined formally. Definition 5. Given an integer k and an initial node (or seed) v ∈ V to which S is initialized (i.e. S = {v}), a link- trace sampling algorithm, A, is a process by which nodes are iteratively selected from among the current neighborhood N (S) and added to S until S = k. Link-trace sampling may also be referred to as crawling (since links are “crawled” to access nodes) or viewed as on- line sampling (since the network G reveals itself iteratively during the course of the sampling process). The key advan- tage of sampling through link-tracing, then, is that complete access to the network in its entirety is not required. This is beneficial for scenarios where the network is either large (e.g. an online social network), decentralized (e.g. an un- structured P2P network), or both (e.g. the Web). As an aside, notice from Definition 5 that we have im- plicitly assumed that the neighbors of a given node can be obtained by visiting that node during the sampling process (i.e. N (S) is known). This, of course, accurately character- izes most real scenarios. For instance, neighbors of a Web page can be gleaned from the hyperlinks on a visited page and neighbors of an individual in an online social network can be acquired by viewing (or “scraping”) the friends list. Having provided a general definition of link-trace sam- pling, we must now address which nodes in N (S) should be preferentially selected at each iteration of the sampling pro- cess. This choice will obviously directly affect the properties of the sample being constructed. We study seven different approaches - all of which are quite simple yet, at the same time, ill-understood in the context of real-world networks. Breadth-First Search (BFS). Starting with a single seed node, the BFS explores the neighbors of visited nodes. At each iteration, it traverses an unvisited neighbor of the ear- liest visited node [14]. In both [30] and [42], it was em- pirically shown that BFS is biased towards high-degree and high-PageRank nodes. BFS is used prevalently to crawl and collect networks (e.g. [41]). Depth-First Search (DFS). DFS is similar to BFS, ex- cept that, at each iteration, it visits an unvisited neighbor of the most recently visited node [14]. Random Walk (RW). A random walk simply selects the next hop uniformly at random from among the neighbors of the current node [37]. Forest Fire Sampling (FFS). FFS, proposed in [34], is essentially a probabilistic version of BFS. At each iteration of a BFS-like process, a neighbor v is only explored according to some “burning” probability p. At p = 1, FFS is identical to BFS. We use p = 0.7, as recommended in [34]. Degree Sampling (DS). The DS strategy involves greedily selecting the node v ∈ N (S) with the highest degree (i.e. number of neighbors). A variation of DS was analytically and empirically studied as a P2P search algorithm in [2]. Notice that, in order to select the node v ∈ N (S) with the highest degree, the process must know N ({v}) for each v ∈ N (S). That is, knowledge of N (N (S)) is required at each iteration. As noted in [2], this requirement is acceptable for some domains such as P2P networks and certain social networks. The DS method is also feasible in scenarios where 1) one is interested in efficiently “downsampling” a network to a connected subgraph, 2) a crawl is repeated and history of the last crawl is available, or 3) the proportion of the network accessed to construct a sample is less important. SEC (Sample Edge Count). Given the currently con- structed sample S, how can we select a node v ∈ N (S) with the highest degree without having knowledge of N (N (S))? The SEC strategy tracks the links from the currently con- structed sample S to each node v ∈ N (S) and selects the node v with the most links from S. In other words, we use the degree of v in the induced subgraph of S ∪ {v} as an approximation of the degree of v in the original network G. Similar approaches have been employed as part of Web crawling strategies with some success (e.g. [9]). XS (Expansion Sampling). The XS strategy is based on the concept of expansion from work on expander graphs and seeks to greedily construct the sample with the maximal ex- pansion: argmaxS: S=k , where k is the desired sample size [23, 40]. At each iteration, the next node v selected for inclusion in the sample is chosen based on the expression: N(S) S argmax v∈N(S) N ({v}) − (N (S) ∪ S). Like the DS strategy, this approach utilizes knowledge of N (N (S)). In Sections 5.3 and 6.2, we will investigate in detail the effect of this expansion bias on various properties of constructed samples. 5. EVALUATING REPRESENTATIVENESS What makes one sampling strategy “better” than another? In computer science, “better” is typically taken to be struc- tural representativeness (e.g. see [25, 29, 35]). That is, sam- ples are considered better if they are more representative of structural properties in the original network. There are, of course, numerous structural properties from which to choose, and, as correctly observed by Ahmed et al. [4], it is not always clear which should be chosen. Rather than choosing arbitrary structural properties as measures of rep- resentativeness, we select specific measures of representa- tiveness that we view as being potentially useful for real ap- plications. We divide these measures (described below) into three categories: Degree, Clustering, and Reach. For each sampling strategy, we generate 100 samples using randomly selected seeds, compute our measures of representativeness on each sample, and plot the average value as sample size grows. (Standard deviations of computed measures are dis- cussed in Section 5.4. Applications for these measures of representativeness are discussed later in Section 7.) Due to space limitations and the large number of networks evalu- ated, for each evaluation measure, we only show results for two datasets that are illustrative of general trends observed in all datasets. However, full results are available as supple- mentary material.2 5.1 Degree The degrees (numbers of neighbors) of nodes in a network is a fundamental and well-studied property. In fact, other graph-theoretic properties such as the average path length between nodes can, in some cases, be viewed as byproducts of degree (e.g. short paths arising from a small number of highly-connected hubs that act as conduits [5]). We study two different aspects of degree (with an eye towards real- world applications, discussed in Section 7). 5.1.1 Measures Degree Distribution Similarity (DistSim). We take the degree sequence of the sample and compare it to that of the original network using the two-sample Kolmogorov-Smirnov (K-S) D-statistic [34], a distance measure. Our objective here is to measure the agreement between the two degree dis- tributions in terms of both shape and location. Specifically, the D-statistic is defined as D = maxx{F (x) − FS(x)}, where x is the range of node degrees, and F and FS are the cumulative degree distributions for G and GS, respec- tively [34]. We compute the distribution similarity by sub- tracting the K-S distance from one. Hub Inclusion (Hubs). In several applications, one cares less about matching the overall degree distribution and more about accumulating the highest degree nodes into the sample quickly (e.g. immunization strategies [13]). For these sce- narios, sampling is used as a tool for information retrieval. Here, we evaluate the extent to which sampling strategies accumulate hubs (i.e. high degree nodes) quickly into the sample. As sample size grows, we track the proportion of 2Supplementary material for this paper is available at: http://arun.maiya.net/papers/supp-netbias.pdf the top K nodes accumulated by the sample. For our tests, we use K = 100. 5.1.2 Results Figure 1 shows the degree distribution similarity (Dist- Sim) and hub inclusion (Hubs) for the Slashdot and Enron datasets. Note that the SEC and DS strategies, both of which are biased to high degree nodes, perform best on hub inclusion (as expected), but are the worst performers on the DistSim measure (which is also a direct result of this bias). (The XS strategy exhibits a similar trend but to a slightly lesser extent.) On the other hand, strategies such as BFS, FFS, and RW tend to perform better on DistSim, but worse on Hubs. For instance, the DS and SEC strategies locate the majority of the top 100 hubs with sample sizes less than 1% in some cases. BFS and FFS require sample sizes of over 10% (and the performance differential is larger when locat- ing hubs ranked higher than 100). More importantly, no strategy performs best on both measures. This, then, sug- gests a tension between goals: constructing small samples of the most well-connected nodes is in conflict with producing small samples exhibiting representative degree distributions. More generally, when selecting sample elements, choices re- sulting in gains for one area can result in losses for another. Thus, these choices must be made in light of how samples will be used - a subject we discuss in greater depth in Sec- tion 7. We conclude this section by briefly noting that the trend observed for SEC seems to be somewhat dependent upon the quality and number of hubs actually present in a network (relative to the size of the network, of course). That is, SEC matches DS more closely as degree distributions ex- hibit longer and denser tails (as shown in Figure 2). We will revisit this in Section 6.3. (Other strategies are sometimes affected similarly, but the trend is much less consistent.) In general, we find SEC best matches DS performance on many of the social networks (as opposed to technological networks such as the PowerGrid with few “good” hubs, lower average degree, and longer path lengths). However, further investi- gation is required to draw firm conclusions on this last point. y t i r a l i XS DEG SEC RW BFS DFS FFS i m S n o i t u b i r t s D e e r g e D i 1 0.9 0.8 0.7 0.6 0.5 0.4 0.3 0.2 0.1 0 0 10 XS DEG SEC RW BFS DFS FFS 1 10 2 10 Sample Size % (log scale) y t i r a l i i m S n o i t i u b i r t s D e e r g e D 1 0.9 0.8 0.7 0.6 0.5 0.4 0.3 0.2 0.1 0 0 10 1 10 2 10 Sample Size % (log scale) (a) Slashdot (DistSim) (b) Enron (DistSim) ) 0 0 1 p o T ( i n o s u c n l I b u H 1 0.9 0.8 0.7 0.6 0.5 0.4 0.3 0.2 0.1 0 0 10 XS DEG SEC RW BFS DFS FFS ) 0 0 1 p o T ( i n o s u c n l I b u H 1 10 2 10 Sample Size % (log scale) 1 0.9 0.8 0.7 0.6 0.5 0.4 0.3 0.2 0.1 0 0 10 XS DEG SEC RW BFS DFS FFS 1 10 2 10 Sample Size % (log scale) (c) Slashdot (Hubs) (d) Enron (Hubs) Figure 1: Evaluating (DistSim) and (Hubs). Results for remaining networks are similar. 5.2 Clustering Many real-world networks, such as social networks, exhibit a much higher level clustering than what one would expect at random [50]. Thus, clustering has been another graph property of interest for some time. Here, we are interested ) 0 0 1 p o T ( i n o s u c n l I b u H ) 0 0 1 p o T ( n o s u c n I b u H l i 1 0.9 0.8 0.7 0.6 0.5 0.4 0.3 0.2 0.1 0 0 10 XS DEG SEC RW BFS DFS FFS 5 10 4 10 3 10 2 10 1 10 t n u o C 2 10 0 10 0 10 1 10 Sample Size % (log scale) 1 10 2 10 Node Degree 3 10 4 10 l a c o L C C 1 0.9 0.8 0.7 0.6 0.5 0.4 0.3 0.2 0.1 0 0 10 XS DEG SEC RW BFS DFS FFS 1 10 2 10 Sample Size % (log scale) l a c o L C C 1 0.9 0.8 0.7 0.6 0.5 0.4 0.3 0.2 0.1 0 0 10 XS DEG SEC RW BFS DFS FFS 1 10 2 10 Sample Size % (log scale) (a) Epinions (Hubs) (b) Epinions (DD) (a) WikiVote (CCloc) (b) HEPTh (CCloc) 1 0.9 0.8 0.7 0.6 0.5 0.4 0.3 0.2 0.1 0 0 10 XS DEG SEC RW BFS DFS FFS 5 10 4 10 3 10 2 10 1 10 t n u o C 2 10 0 10 0 10 1 10 Sample Size % (log scale) 1 10 2 10 Node Degree 3 10 4 10 l l a b o G C C 1 0.9 0.8 0.7 0.6 0.5 0.4 0.3 0.2 0.1 0 0 10 XS DEG SEC RW BFS DFS FFS 0.5 0.4 0.3 0.2 0.1 XS DEG SEC RW BFS DFS FFS l l a b o G C C 1 10 Sample Size % (log scale) 2 10 0 0 10 1 10 2 10 Sample Size % (log scale) (c) Gnutella31 (Hubs) (d) Gnutella31 (DD) (c) WikiVote (CCglb) (d) HEPTh (CCglb) Figure 2: Performance of SEC on Hubs (shown in green on left) is observed to be dependent on the tail of the de- gree distributions (DD). SEC matches DS more closely when more and better quality hubs are present. For Hubs, SEC generally performs best on the social networks evaluated. in evaluating the extent to which samples exhibit the level of clustering present in the original network. We employ two notions of clustering, which we now describe. 5.2.1 Measures Local Clustering Coefficient (CCloc). The local clus- tering coefficient [43] of a node captures the extent to which the node’s neighbors are also neighbors of each other. For- mally, the local clustering coefficient of a node is defined dv (dv −1) where dv is the degree of node v and as CL(v) = ℓ is the number of links among the neighbors of v. The average local clustering coefficient for a network is simply Pv∈V CL(v) 2ℓ V . Global Clustering Coefficient (CCglb). The global clustering coefficient [43] is a function of the number of tri- angles in a network. It is measured as the number of closed triplets divided by the number of connected triples of nodes. 5.2.2 Results Results for clustering measures are less consistent than for other measures. Overall, DFS and RW strategies appear to fare relatively better than others. We do observe that, for many strategies and networks, estimates of clustering are initially higher-than-actual and then gradually decline (see Figure 3). This agrees with intuition. Nodes in clus- ters should intuitively have more paths leading to them and will, thus, be encountered earlier in a sampling process (as opposed to nodes not embedded in clusters and located in the periphery of a network). This, then, should be taken into consideration in applications where accurately match- ing clustering levels is important. 5.3 Network Reach We propose a new measure of representativeness called network reach. As a newer measure, network reach has ob- viously received considerably less attention than Degree and Clustering within the existing literature, but it is, neverthe- less, a vital measure for a number of important applications (as we will see in Section 7). Network reach captures the extent to which a sample covers a network. Intuitively, for a sample to be truly representative of a large network, it Figure 3: Evaluating CCglb and CCloc. should consist of nodes from diverse portions of the net- work, as opposed to being relegated to a small “corner” of the graph. This concept will be made more concrete by discussing in detail the two measures of network reach we employ: community reach and the discovery quotient. 5.3.1 Measures Community Reach (CNM and RAK). Many real-world networks exhibit what is known as community structure. A community can be loosely defined as a set of nodes more densely connected among themselves than to other nodes in the network. Although there are many ways to represent community structure depending on various factors such as whether or not overlapping is allowed, in this work, we rep- resent community structure as a partition: a collection of disjoint subsets whose union is the vertex set V [18]. Under this representation, each subset in the partition represents a community. The task of a community detection algorithm is to identify a partition such that vertices within the same subset in the partition are more densely connected to each other than to vertices in other subsets [18]. For the criterion of community reach, a sample is more representative of the network if it consists of nodes from more of the communi- ties in the network. We measure community reach by taking the number of communities represented in the sample and dividing by the total number of communities present in the original network. Since a community is essentially a cluster of nodes, one might wonder why we have included commu- nity reach as a measure of network reach, rather than as a measure of clustering. The reason is that we are slightly less interested in the structural details of communities de- tected here. Rather, our aim is to assess how “spread out” a sample is across the network. Since community detec- tion is somewhat of an inexact science (e.g. see [21]), we measure community reach with respect to two separate al- gorithms. We employ both the method proposed by Clauset et al. in [12] (denoted as CNM) and the approach proposed by Raghavan et al. in [45] (denoted as RAK). Essentially, for our purposes, we are defining communities simply as the output of a community detection algorithm. Discovery Quotient (DQ). An alternative view of net- work reach is to measure the proportion of the network that is discovered by a sampling strategy. The number of nodes discovered by a strategy is defined as S ∪ N (S). The dis- covery quotient is this value normalized by the total number of nodes in a network: . Intuitively, we are defin- S∪N(S) V ing the reach of a sample here by measuring the extent to which it is one hop away from the rest of the network. As we will discuss in Section 7, samples with high discovery quo- tients have several important applications. Note that a sim- ple greedy algorithm for coverage problems such as this has a well-known sharp approximation bound of 1 − 1/e [16,39]. However, link-trace sampling is restricted to selecting subse- quent sample elements from the current neighborhood N (S) at each iteration, which results in a much smaller search space. Thus, this approximation guarantee can be shown not to hold within the context of link-trace sampling. 5.3.2 Results As shown in Figure 4, the XS strategy displays the over- whelmingly best performance on all three measures of net- work reach. We highlight several observations here. First, the extent to which the XS strategy outperforms all others on the RAK and CNM measures is quite striking. We posit that the expansion bias of the XS strategy “pushes” the sam- pling process towards the inclusion of new communities not already seen (see also [40]). In Section 6.2, we will analyt- ically examine this connection between expansion bias and community reach. On the other hand, the SEC method ap- pears to be among the least effective in reaching different communities or clusters. We attribute this to the fact that SEC preferentially selects nodes with many connections to nodes already sampled. Such nodes are likely to be mem- bers of clusters already represented in the sample. Second, on the DQ measure, it is surprising that the DS strategy, which explicitly selects high degree nodes, often fails to even come close to the XS strategy. We partly attribute this to an overlap in the neighborhoods of well-connected nodes. By explicitly selecting nodes that contribute to expansion, the XS strategy is able to discover a much larger proportion of the network in the same number of steps - in some cases, by actively sampling comparatively lower degree nodes. Fi- nally, it is also surprising that the BFS strategy, widely used to crawl and explore online social networks (e.g [41]) and other graphs (e.g. [42]), performs quite dismally on all three measures. In short, we find that nodes contributing most to the expansion of the sample are unique in that they provide specific and significant advantages over and above those pro- vided by nodes that are simply well-connected and those ac- cumulated through standard BFS-based crawls. These and previously mentioned results are in contrast to the conven- tional wisdom followed in much of the existing literature (e.g. [2, 13, 30, 41, 42]). 5.4 A Note on Seed Sensitivity As described, link-trace sampling methods are initiated from randomly selected seeds. This begs the question: How sensitive are these results to the seed supplied to a strat- egy? Figure 5 shows the standard deviation of each sam- pling strategy for both hub inclusion and network reach as sample size grows. We generally find that methods with the most explicit biases (XS, SEC, DS) tend to exhibit the least seed sensitivity and variability, while the remaining meth- ods (BFS, DFS, FFS, RW) exhibit the most. This trend is exhibited across all measures and all datasets. 6. ANALYZING SAMPLING BIASES Let us briefly summarize two main observations from Sec- tion 5. We saw that the XS strategy dramatically outper- ) K A R ( h c a e R y t i n u m m o C 1 0.9 0.8 0.7 0.6 0.5 0.4 0.3 0.2 0.1 0 0 10 XS DEG SEC RW BFS DFS FFS 1 10 2 10 Sample Size % (log scale) ) K A R ( h c a e R y t i n u m m o C 1 0.9 0.8 0.7 0.6 0.5 0.4 0.3 0.2 0.1 0 0 10 XS DEG SEC RW BFS DFS FFS 1 10 2 10 Sample Size % (log scale) (a) HEPTh (RAK) (b) Amazon (RAK) ) M N C ( h c a e R y t i n u m m o C 1 0.9 0.8 0.7 0.6 0.5 0.4 0.3 0.2 0.1 0 0 10 XS DEG SEC RW BFS DFS FFS 1 10 2 10 Sample Size % (log scale) ) M N C ( h c a e R y t i n u m m o C 1 0.9 0.8 0.7 0.6 0.5 0.4 0.3 0.2 0.1 0 0 10 XS DEG SEC RW BFS DFS FFS 1 10 2 10 Sample Size % (log scale) (c) HEPTh (CNM) (d) Amazon (CNM) t n e i t o u Q y r e v o c s D i 1 0.9 0.8 0.7 0.6 0.5 0.4 0.3 0.2 0.1 0 0 10 XS DEG SEC RW BFS DFS FFS 1 10 2 10 Sample Size % (log scale) t n e i t o u Q y r e v o c s D i 1 0.9 0.8 0.7 0.6 0.5 0.4 0.3 0.2 0.1 0 0 10 XS DEG SEC RW BFS DFS FFS 1 10 2 10 Sample Size % (log scale) (e) HEPTh (DQ) (f) Amazon (DQ) Figure 4: Evaluating network reach. Results for remain- ing networks are similar with XS exhibiting superior perfor- mance on all three criteria. 0.045 0.04 0.035 0.03 0.025 0.02 0.015 0.01 0.005 ) . v e D . t d S ( Q D 0 0 10 XS DEG SEC RW BFS DFS FFS 0.18 0.16 0.14 0.12 0.1 0.08 0.06 0.04 0.02 ) . v e D . d t S ( s b u H XS DEG SEC RW BFS DFS FFS Sample Size % (log scale) 1 10 2 10 0 0 10 Sample Size % (log scale) 1 10 2 10 (a) Epinions (DQ) (b) Epinions (Hubs) Figure 5: Standard deviation for DQ and Hubs on Epinions network. Results are similar for remaining networks. formed all others in accumulating nodes from many differ- ent communities. We also saw that the SEC strategy was often a reasonably good approximation to directly sampling high degree nodes and locates the set of most well-connected nodes significantly faster than most other methods. Here, we turn our attention to analytically examining these ob- served connections. We begin by briefly summarizing some existing analytical results. 6.1 Existing Analytical Results Random Walks (RW). There is a fairly large body of re- search on random walks and Markov chains (see [37] for an excellent survey). A well-known analytical result states that the probability (or stationary probability) of residing at any node v during a random walk on a connected, undirected graph converges with time to dv 2·E , where dv is the degree of node v [37]. In fact, the hitting time of a random walk (i.e. the expected number of steps required to reach a node beginning from any node) has been analytically shown to be directly related to this stationary probability [24]. Ran- dom walks, then, are naturally biased towards high degree (and high PageRank) nodes, which provides some theoreti- cal explanation as to why RW performs slightly better than other strategies (e.g. BFS) on measures such as hub inclu- sion. However, as shown in Figure 1, it is nowhere near the best performers. Thus, these analytical results appear only to hold in the limit and fail to predict actual sampling performance. Degree Sampling (DS). In studying the problem of search- ing peer-to-peer networks, Adamic et al. [2] proposed and analyzed a greedy search strategy very similar to the DS sampling method. This strategy, which we refer to as a degree-based walk, was analytically shown to quickly find the highest-degree nodes and quickly cover large portions of scale-free networks. Thus, these results provide a theoretical explanation for performance of the DS strategy on measures such as hub inclusion and the discovery quotient. Other Results. As mentioned in Section 2, to the best of our knowledge, much of the other analytical results on sam- pling bias focus on negative results [1, 15, 30, 31, 46]. Thus, these works, although intriguing, may not provide much help in the way of explaining positive results shown in Section 5. We now analyze two methods for which there are little or no existing analytical results: XS and SEC. 6.2 Analyzing XS Bias A widely used measure for the “goodness” or the strength of a community in graph clustering and community detec- tion is conductance [26], which is a function of the fraction of total edges emanating from a sample (lower values mean stronger communities): ϕ(S) = Pi∈S,j∈S aij min(a(S), a(S)) where aij are entries of the adjacency matrix representing the graph and a(S) = Pi∈S Pj∈V aij , which is the total number of edges incident to the node set S. It can be shown that, provided the conductance of com- munities is sufficiently low, sample expansion is directly af- fected by community structure. Consider a simple random graph model with vertex set V and a community struc- ture represented by partition C = {C1, . . . , CC} where C1 ∪ . . . ∪ CC = V . Let ein and eout be the number of each node’s edges pointing within and outside the node’s com- munity, respectively. These edges are connected uniformly at random to nodes either within or outside a node’s com- munity, similar to a configuration model (e.g., [11]). Note that both ein and eout are related directly to conductance. When conductance is lower, eout is smaller3 as compared to ein. The following theorem expresses the link between ex- pansion and community reach in terms of these inward and outward edges. Theorem 1. Let S be the current sample, v be a new node to be added to S, and n be the size of v’s community. If eout < V (ein)2 n(V +einS) , then the expected expansion of S∪{v} is higher when v is in a new community than when v is in a current community. Proof. Let Xnew be the expected value for N ({v}) − N (S) ∪ S when v is in a new community and let Xcurr be the expected value when not. We compute an upper bound on Xcurr and a lower bound on Xnew. Deriving Xcurr: Assume v is affiliated with a current com- munity already represented by at least one node in S. Since we are computing an upper bound on Xcurr, we assume there is exactly one node from S within v’s community, as this is the minimum for v’s community to be a current com- munity. By the linearity of expectations, the upper bound on Xcurr is eout + (n−ein )ein is the expected number of nodes in v’s community that are both linked to v and in the set V − (N (S) ∪ S). , where the term (n−ein )ein n n Deriving Xnew: Assume v belongs to a new community not already represented in S. (By definition, no nodes in S will be in v’s community.) Applying the linearity of expectations once again, the lower bound on Xnew is ein − eoutS ein V , where the term eoutS ein V is the expected number of nodes in v’s community that are both linked to v and already in N (S). Solving for eout, if eout < V (ein)2 n(V +einS) , then Xnew > Xcurr. Theorem 1 shows analytically the link between expansion and community structure - a connection that, until now, has only been empirically demonstrated [40]. Thus, a theoretical basis for performance of the XS strategy on community reach is revealed. 6.3 Analyzing SEC Bias Recall that the SEC method uses the degree of a node v in the induced subgraph GS∪{v} as an estimation for the de- gree of v in G. In Section 5, we saw that this choice performs quite well in practice. Here, we provide theoretical justifi- cation for the SEC heuristic. Consider a random network G with some arbitrary expected degree sequence (e.g. a power law random graph under the so-called G(w) model [11]) and a sample S ⊂ V . Let d(·, ·) be a function that returns the expected degree of a given node in a given random network (see [11] for more information on expected degree sequences). Then, it is fairly straightforward to show the following holds. Proposition 1. For any two nodes v, w ∈ N (S), if d(v, G) ≥ d(w, G), then d(v, GS∪{v}) ≥ d(w, GS∪{w}). Proof. The probability of an edge between any two nodes where ∆ = Pm∈V d(m, G). Let i and j in G is d(i,G)·d(j,G) δ = d(v, GS∪{v}) − d(w, GS∪{w}). Then, ∆ δ = X x∈S d(x, G) · d(v, G) ∆ − X = (d(v, G) − d(w, G)) X x∈S d(x, G) · d(w, G) ∆ x∈S d(x, G) ∆ (1) (2) 3Suppose conductance of a vertex set Y is ϕ(Y ), the total number of edges incident to Y is e, and ein and eout are random variables denoting the inward and outward edges, respectively, of each node (as opposed to constant values). Then, E(eout) = eϕ(Y ) . If ϕ(Y ) < Y 2 3 , then E(eout) < E(ein). (In this example, the expectations are over nodes in Y only.) and E(ein) = 2e(1−ϕ(Y )) Y Since δ ≥ 0 only when d(v, G) ≥ d(w, G), the proposition holds. Combining Proposition 1 with analytical results from [2] (described in Section 6.1) provides a theoretical basis for ob- served performance of the SEC strategy on measures such as hub inclusion. Finally, recall from Section 5.1.2 that the extent to which SEC matched the performance of DS on Hubs seemed to partly depend on the tail of degree dis- tributions. Proposition 1 also yields insights into this phe- nomenon. Longer and denser tails allow for more “slack” when deviating from these expectations of random variables (as in real-world link patterns that are not purely random). 7. APPLICATIONS FOR OUR FINDINGS We now briefly describe ways in which some of our find- ings may be exploited in important, real-world applications. Although numerous potential applications exist, we focus here on three areas: 1) Outbreak Detection 2) Landmarks and Graph Exploration 3) Marketing. 7.1 Practical Outbreak Detection What is the most effective and efficient way to predict and prevent a disease outbreak in a social network? In a recent paper, Christakis and Fowler studied outbreak detection of the H1N1 flu among college students at Harvard Univer- sity [10]. Previous research has shown that well-connected (i.e. high degree) people in a network catch infectious dis- eases earlier than those with fewer connections [13, 17, 51]. Thus, monitoring these individuals allows forecasting the progression of the disease (a boon to public health officials) and immunizing these well-connected individuals (when im- munization is possible) can prevent or slow further spread. Unfortunately, identifying well-connected individuals in a population is non-trivial, as access to their friendships and connections is typically not fully available. And, collect- ing this information is time-consuming, prohibitively expen- sive, and often impossible for large networks. Matters are made worse when realizing that most existing network-based techniques for immunization selection and outbreak detec- tion assume full knowledge of the global network structure (e.g. [36, 48]). This, then, presents a prime opportunity to exploit the power of sampling. To identify well-connected students and predict the out- break, Christakis and Fowler [10] employed a sampling tech- nique called acquaintance sampling (ACQ) based on the so-called friendship paradox [10, 13, 51]. The idea is that random neighbors of randomly selected nodes in a network will tend to be highly-connected [13, 17, 51]. Christakis and Fowler [10], therefore, sampled random friends of randomly selected students with the objective of constructing a sam- ple of highly-connected individuals. Based on our afore- mentioned results, we ask: Can we do better than this ACQ strategy? In previous sections, we showed empirically and analytically that the SEC method performs exceedingly well in accumulating hubs. (It also happens to require less infor- mation than DS and XS, the other top performers.) Figure 6 shows the sample size required to locate the top-ranked well- connected individuals for both SEC and ACQ. The perfor- mance differential is quite remarkable, with the SEC method faring overwhelmingly better in quickly zeroing in on the set of most well-connected nodes. Aside from its superior performance, SEC has one additional advantage over the ACQ method employed by Christakis and Fowler. The ACQ method assumes that nodes in V can be selected uniformly at random. (ACQ, then, is not a link-trace sampling method.) By contrast, SEC, as a pure link-trace sampling strategy, has no such re- quirement and, thus, can be applied in realistic scenarios for which ACQ is unworkable. It is, in fact, dependent on this [13]. SEC ACQ 0.2 0.15 0.1 0.05 ) V / S i ( e z S e p m a S l SEC ACQ 0.5 0.4 0.3 0.2 0.1 ) V / S ( i e z S e p m a S l 0 0 10 20 30 50 40 60 Degree Rank 70 80 90 100 0 0 10 20 30 50 40 60 Degree Rank 70 80 90 100 (a) Slashdot (b) CondMat Figure 6: Comparison of SEC and ACQ on quickly locat- ing well-connected individuals (lower is better). SEC far surpasses ACQ. Results are similar for every network. 7.2 Marketing Recall from Section 5.3 that a community in a network is a cluster of nodes more densely connected among them- selves than to others. Identifying communities is important, as they often correspond to real social groups, functional groups, or similarity (both demographic and not) [18]. The ability to easily construct a sample consisting of members from diverse groups has several important applications in marketing. Marketing surveys often seek to construct strat- ified samples that collectively represent the diversity of the population [28]. If the attributes of nodes are not known in advance, this can be challenging. The XS strategy, which exhibited the best community reach, can potentially be very useful here. Moreover, it has the added power of being able to locate members from diverse groups with absolutely no a priori knowledge of demographics attributes, social vari- ables, or the overall community structure present in the net- work. There is also recent evidence to suggest that being able to construct a sample from many different communities can be an asset in effective word-of-mouth marketing [8]. This, then, represents yet another potential marketing ap- plication for the XS strategy. 7.3 Landmarks and Graph Exploration Landmark-based methods represent a general class of algo- rithms to compute distance-based metrics in large networks quickly [44]. The basic idea is to select a small sample of nodes (i.e. the landmarks), compute offline the distances from these landmarks to every other node in the network, and use these pre-computed distances at runtime to approx- imate distances between pairs of nodes. As noted in [44], for this approach to be effective, landmarks should be selected so that they cover significant portions of the network. Based on our findings for network reach in Section 5.3, the XS strategy overwhelmingly yields the best discovery quotient and covers the network significantly better than any other strategy. Thus, it represents a promising landmark selection strategy. Our results for the discovery quotient and other measures of network reach also yield important insights into how graphs should best be explored, crawled, and searched. As shown in Figure 4, the most prevalently used method for exploring networks, BFS, ranks low on measures of net- work reach. This suggests that the BFS and its pervasive use in social network data acquisition and exploration (e.g. see [41]) should possibly be examined more closely. 8. CONCLUSION We have conducted a detailed study on sampling biases in real-world networks. In our investigation, we found the BFS, a widely-used method for sampling and crawling net- works, to be among the worst performers in both discovering the network and accumulating critical, well-connected hubs. We also found that sampling biases towards high expan- sion tend to accumulate nodes that are uniquely different from those that are simply well-connected or traversed dur- ing a BFS-based strategy. These high-expansion nodes tend to be in newer and different portions of the network not already encountered by the sampling process. We further demonstrated that sampling nodes with many connections from those already sampled is a reasonably good approxi- mation to sampling high degree nodes. Finally, we demon- strated several ways in which these findings can be exploited in real-world application such as disease outbreak detection and marketing. For future work, we intend to investigate ways in which the top-performing sampling strategies can be enhanced for even wider applicability. One such direc- tion is to investigate the effects of alternating or combining different biases into a single sampling strategy. 9. REFERENCES [1] D. Achlioptas, A. Clauset, D. Kempe, and C. Moore. On the bias of traceroute sampling: or, power-law degree distributions in regular graphs. In STOC ’05. [2] L. A. Adamic, R. M. Lukose, A. R. Puniyani, and B. A. Huberman. Search in power-law networks. Physical Review E, 64(4):046135+, Sept. 2001. [3] N. K. Ahmed, F. Berchmans, J. Neville, and R. Kompella. Time-based sampling of social network activity graphs. In MLG ’10. [21] B. H. Good, Y.-A. de Montjoye, and A. Clauset. Performance of modularity maximization in practical contexts. Physical Review E, 81(4):046106+, Apr. 2010. [22] M. R. Henzinger, A. Heydon, M. Mitzenmacher, and M. Najork. On near-uniform URL sampling. In WWW ’00. [23] S. Hoory, N. Linial, and A. Wigderson. Expander Graphs and Their Applications. Bull. Amer. Math. Soc, 43, 2006. [24] J. Hopcroft and D. Sheldon. Manipulation-resistant reputations using hitting time. In WAW’07. [25] C. Hubler, H.-P. Kriegel, K. Borgwardt, and Z. Ghahramani. Metropolis Algorithms for Representative Subgraph Sampling. In ICDM ’08. [26] R. Kannan, S. Vempala, and A. Vetta. On clusterings: Good, bad and spectral. J. ACM, 51(3):497–515, May 2004. [27] J. Kleinberg. Complex Networks and Decentralized Search Algorithms. In International Congress of Mathematicians (ICM), 2006. [28] E. D. Kolaczyk. Statistical Analysis of Network Data, chapter 5. Springer, 2009. [29] V. Krishnamurthy, M. Faloutsos, M. Chrobak, J. Cui, L. Lao, and A. Percus. Sampling large Internet topologies for simulation purposes. Computer Networks, 51(15):4284–4302, Oct. 2007. [30] M. Kurant, A. Markopoulou, and P. Thiran. On the bias of BFS. Arxiv e-print (arXiv:1004.1729v1), Apr. 2010. [31] A. Lakhina, J. W. Byers, M. Crovella, and P. Xie. Sampling Biases in IP Topology Measurements. In INFOCOM ’03. [32] S. H. Lee, P. J. Kim, and H. Jeong. Statistical properties of sampled networks. Physical Review E, 73(1):016102+, Jan. 2006. [33] J. Leskovec. Stanford Large Network Dataset Collection. http://snap.stanford.edu/data/. [4] N. K. Ahmed, J. Neville, and R. Kompella. Reconsidering the [34] J. Leskovec and C. Faloutsos. Sampling from large graphs. In Foundations of Network Sampling. In WIN ’10. KDD ’06. [5] A.-L. Barabasi and R. Albert. Emergence of Scaling in Random [35] J. Leskovec, J. Kleinberg, and C. Faloutsos. Graphs over Time: Networks. Science, 286(5439):509–512, Oct. 1999. [6] M. Bogun´a, R. P. Satorras, A. D. Guilera, and A. Arenas. Models of social networks based on social distance attachment. Physical Review E, 70(5):056122+, Nov. 2004. [7] P. Boldi, M. Santini, and S. Vigna. Do Your Worst to Make the Densification Laws, Shrinking Diameters and Possible Explanations. In KDD ’05. [36] J. Leskovec, A. Krause, C. Guestrin, C. Faloutsos, J. VanBriesen, and N. Glance. Cost-effective outbreak detection in networks. In KDD ’07. Best: Paradoxical Effects in PageRank Incremental Computations. In WAW ’04. [37] L. Lovasz. Random Walks on Graphs: A Survey. Combinatorics: Paul Erdos is 80, II, 1994. [8] T. Cao, X. Wu, S. Wang, and X. Hu. OASNET: an optimal allocation approach to influence maximization in modular social networks. In SAC ’10. [9] J. Cho, H. G. Molina, and L. Page. Efficient crawling through URL ordering. Computer Networks and ISDN Systems, 30(1–7):161–172, 1998. [10] N. A. Christakis and J. H. Fowler. Social Network Sensors for Early Detection of Contagious Outbreaks. PLoS ONE, 5(9):e12948+, Sept. 2010. [11] F. Chung and L. Lu. Connected Components in Random Graphs with Given Expected Degree Sequences. Annals of Combinatorics, 6(2):125–145, Nov. 2002. [12] A. Clauset, M. E. J. Newman, and C. Moore. Finding community structure in very large networks. Physical Review E, 70(6):066111+, Dec. 2004. [13] R. Cohen, S. Havlin, and D. ben Avraham. Efficient Immunization Strategies for Computer Networks and Populations. arXiv:cond-mat/0207387v3, Dec. 2003. [14] T. H. Cormen, C. E. Leiserson, R. L. Rivest, and C. Stein. Introduction to Algorithms. McGraw-Hill Science / Engineering / Math, 2nd edition, Dec. 2003. [15] E. Costenbader. The stability of centrality measures when networks are sampled. Social Networks, 25(4):283–307, Oct. 2003. [16] U. Feige. A threshold of ln n for approximating set cover. J. ACM, 45(4):634–652, July 1998. [17] S. L. Feld. Why Your Friends Have More Friends Than You Do. The Am. J. of Sociology, 96(6):1464–1477, 1991. [18] S. Fortunato. Community detection in graphs. arXiv:0906.0612v2 [physics.soc-ph], Jan. 2010. [19] O. Frank. Models and Methods in Social Network Analysis (Structural Analysis in the Social Sciences), chapter 3. Cambridge University Press, Feb. 2005. [20] M. Gjoka, M. Kurant, C. T. Butts, and A. Markopoulou. A Walk in Facebook: Uniform Sampling of Users in Online Social Networks. arXiv e-print (arXiv:0906.0060v3), Feb. 2011. [38] L. Lovasz. Very large graphs. arXiv:0902.0132v1, Feb. 2009. [39] A. S. Maiya and T. Y. Berger Wolf. Expansion and search in networks. In CIKM ’10. [40] A. S. Maiya and T. Y. Berger-Wolf. Sampling Community Structure. In WWW ’10. [41] A. Mislove, M. Marcon, K. P. Gummadi, P. Druschel, and B. Bhattacharjee. Measurement and analysis of online social networks. In IMC ’07. [42] M. Najork. Breadth-first search crawling yields high-quality pages. In WWW ’01. [43] M. E. J. Newman. The structure and function of complex networks. SIAM Review, 45:167–256, Mar. 2003. [44] M. Potamias, F. Bonchi, C. Castillo, and A. Gionis. Fast shortest path distance estimation in large networks. In CIKM ’09. [45] U. N. Raghavan, R. Albert, and S. Kumara. Near linear time algorithm to detect community structures in large-scale networks. Physical Review E, 76(3):036106+, Sept. 2007. [46] M. P. H. Stumpf, C. Wiuf, and R. M. May. Subnets of scale-free networks are not scale-free: Sampling properties of networks. PNAS, 102(12):4221–4224, Mar. 2005. [47] D. Stutzbach, R. Rejaie, N. Duffield, S. Sen, and W. Willinger. On unbiased sampling for unstructured peer-to-peer networks. IEEE/ACM Trans. Netw., 17(2):377–390, 2009. [48] H. Tong, B. A. Prakash, C. Tsourakakis, T. E. Rad, C. Faloutsos, and D. H. Chau. On the Vulnerability of Large Graphs. In ICDM ’10. [49] D. Tsoumakos and N. Roussopoulos. Analysis and comparison of P2P search methods. In InfoScale ’06. [50] D. J. Watts and S. H. Strogatz. Collective dynamics of ’small-world’ networks. Nature, 393(6684):440–442, June 1998. [51] E. W. Zuckerman and J. T. Jost. What Makes You Think You’re so Popular? Self-Evaluation Maintenance and the Subjective Side of the ”Friendship Paradox”. Social Psychology Quarterly, 64(3), 2001.
1812.04367
2
1812
2019-12-30T18:06:23
Semantic Trails of City Explorations: How Do We Live a City
[ "cs.SI" ]
The knowledge of city exploration trails of people is in short supply because of the complexity in defining meaningful trails representative of individual behaviours and in the access to actionable data. Existing datasets have only recorded isolated check-ins of activities featured by opaque venue types. In this paper, we fill the gaps in defining what is a semantic trail of city exploration and how it can be generated by integrating different data sources. Furthermore, we publicly release two datasets holding millions of semantic trails each and we discuss their most salient characteristics. We finally present an application using these datasets to build a recommender system meant to guide tourists while exploring a city.
cs.SI
cs
Noname manuscript No. (will be inserted by the editor) Semantic Trails of City Explorations: How Do We Live a City Diego Monti · Enrico Palumbo · Giuseppe Rizzo · Raphael Troncy · Thibault Ehrhart · Maurizio Morisio 9 1 0 2 c e D 0 3 ] I S . s c [ 2 v 7 6 3 4 0 . 2 1 8 1 : v i X r a Received: date / Accepted: date Abstract The knowledge of city exploration trails of people is in short supply because of the complexity in defining meaningful trails representative of individual behaviours and in the access to actionable data. Ex- isting datasets have only recorded isolated check-ins of activities featured by opaque venue types. In this pa- per, we fill the gaps in defining what is a semantic trail of city exploration and how it can be generated by inte- grating different data sources. Furthermore, we publicly Diego Monti Politecnico di Torino, Corso Duca degli Abruzzi 24, 10129 Turin, Italy Tel.: +39-011-0907087 Fax: +39-011-0907099 E-mail: [email protected] Enrico Palumbo Istituto Superiore Mario Boella, Via Pier Carlo Boggio 61, 10138 Turin, Italy EURECOM, Sophia Antipolis, 450 Route des Chappes, 06410 Biot, France Politecnico di Torino, Corso Duca degli Abruzzi 24, 10129 Turin, Italy E-mail: [email protected] Giuseppe Rizzo LINKS Foundation, Via Pier Carlo Boggio 61, 10138 Turin, Italy E-mail: [email protected] Raphael Troncy EURECOM, Sophia Antipolis, 450 Route des Chappes, 06410 Biot, France E-mail: [email protected] Thibault Ehrhart EURECOM, Sophia Antipolis, 450 Route des Chappes, 06410 Biot, France E-mail: [email protected] Maurizio Morisio Politecnico di Torino, Corso Duca degli Abruzzi 24, 10129 Turin, Italy E-mail: [email protected] release two datasets holding millions of semantic trails each and we discuss their most salient characteristics. We finally present an application using these datasets to build a recommender system meant to guide tourists while exploring a city. Keywords Semantic trail · Collective behavior · Location-based social networks · Tourist recommenda- tion · Sequence recommendation. 1 Introduction Location-based social networks (LBSNs) allow users to share their position with friends, or even publicly, by performing a check-in when they visit a certain venue or point-of-interest (POI). A POI can be defined as an entity that has a somewhat fixed and physical exten- sion, like a landmark, a building, or a city.1 A check-in is typically associated with many information of potential interest for researchers specialized in different domains, from urban mobility to recommender systems. For ex- ample, many LBSNs classify their POIs in consistent taxonomies, that assign an explicit semantic meaning to each check-in. Furthermore, each venue has a physi- cal location, which can be represented by its geograph- ical coordinates, and each check-in is performed at a specific point in time. The contribution of this work is threefold: we for- mally define what is a set of temporally neighboring ac- tivities, which we called semantic trail of check-ins, and how to generate it, we propose a mapping between the venue categories available in Foursquare and the corre- sponding Schema.org terms, and we introduce the Se- mantic Trails Datasets (STDs) which are two different 1 As formalized by https://schema.org/Place. 2 Diego Monti et al. datasets of semantically annotated trails created start- ing from check-ins performed on the Foursquare social network. Differently from other datasets already avail- able, we analyzed the check-ins at our disposal in order to group them into sequences of activities. Furthermore, we enriched the datasets by adding valuable semantic information, that is the Schema.org terms correspond- ing to the Foursquare category of the associated venues as well as the GeoNames and Wikidata entities repre- senting the city in which the check-in was performed. The remainder of this paper is structured as fol- lows. In Section 2, we review related works, while, in Section 3, we introduce the procedure used to generate the STDs. Then, we analyze the main characteristics of our datasets in Section 4 and we present a possible use case in Section 5. Finally, we conclude and outline future works in Section 6. venues. A typical task addressed in literature is the pre- diction of the next POI in which a user is likely to be willing to go during the exploration of a city. Different approaches have been considered to ad- dress this problem: for example, Cheng et al. [1] pro- posed an extension of the matrix factorization method capable of considering the temporal relations in the check-in sequence, as well as the spatial constraints from the user. Ye et al. [18] introduced a framework based on a mixed hidden Markov model capable of first suggesting the most relevant venue categories and then selecting the actual suggested POIs given the estimated category distribution. Feng et al. [3] addressed the next new POI recommendation problem using a personal- ized ranking metric embedding method. More recently, Palumbo et al. [8] proposed to recommend venue cat- egories using recurrent neural networks, while S´anchez et al. [12] exploited cross-domain techniques. 2 Related Work Different authors have analyzed user-created geograph- ical data obtained from LBSNs. In the following, we distinguish among works related to data-driven studies (Section 2.1), next POI recommendation (Section 2.2), and check-in datasets (Section 2.3). 2.1 Data-driven Studies Several works exploited LBSNs for a data-driven under- standing of cities and characterizing the social behav- iors related to urban mobility. Noulas et al. [7] relied on a spectral clustering algorithm to create a semantic rep- resentation of city neighborhoods and to identify user communities that visit similar categories of places. Li et al. [4] performed a statistical study with the aim of unraveling the correlations among venue categories and their popularity using a large check-ins dataset with 2.4 million venues collected from different geographical re- gions. Preot¸iuc-Pietro et al. [10] proposed to create a semantic representation of an urban area by relying on a bag of venue categories: they used such a representation to define a similarity measure between cities. More re- cently, Rizzo et al. [11] exploited density-based cluster- ing techniques on a dataset containing venue categories to create high level summaries of the neighborhoods. 2.2 Next POI Recommendation 2.3 Check-in Datasets Some check-in datasets collected from LBSNs are al- ready publicly available. The NYC Restaurant Rich Dataset [16] includes check-ins of restaurant venues in New York City only, as well as tip and tag data col- lected from Foursquare from October 2011 to February 2012. The NYC and Tokyo Check-in Dataset [17] con- tains check-ins performed in New York City and Tokyo collected from April 2012 to February 2013, together with their timestamp, GPS coordinates and venue cat- egory. The Global-Scale Check-in Dataset (GSCD) [15] includes long-term check-in data collected from April 2012 to September 2013 only considering the 415 most popular cities on Foursquare. All the previous datasets were created by Yang et al. [17,15] and they are publicly available on the Web.2 However, none of them is focused on the analysis of temporal sequences of check-ins. In contrast, our ap- proach for constructing semantic trails is similar to the one proposed by Parent et al. [9], but instead of relying on raw GPS data, we consider check-ins from LBSNs and we semantically annotate them. 3 Semantic Trails Datasets In this section, we detail the process that we followed for building the Semantic Trails Datasets (STDs) from the collections of check-ins at our disposal, that will be described in Section 4. The exploited algorithm is Other studies relied on LBSNs data to create algorithms capable of providing personalized recommendations of 2 https://sites.google.com/site/yangdingqi/home/ foursquare-dataset Semantic Trails of City Explorations: How Do We Live a City 3 publicly available in our GitHub repository,3 while the resulting datasets have been published on figshare [6]. 3.1 Dataset Generation We based our generation strategy on two initial col- lections of check-ins obtained from Foursquare, namely the GSCD and a second one created by the authors. Each of these sources consists in two different files seri- alized using a tabular format. The first one contains the check-ins collected from the platform, while the second one lists the venues involved and their details. More formally, each check-in associates a specific user with a certain venue and a timestamp, which represents the point in time when the check-in was performed. Definition 1 Given the space of venues V, the space of users U, the space of timestamps T , a check-in c ∈ C is a tuple c = (ν, υ, τ ), where ν ∈ V is the venue in which the user υ ∈ U was located at the timestamp τ ∈ T . In contrast, a POI is characterized by a unique iden- tifier, its geographical coordinates, and a category se- lected from the Foursquare taxonomy.4 Definition 2 Given the space of categories K, a venue or point-of-interest (POI) ν ∈ V is a tuple ν = (ϕ, λ, κ), where ϕ is the latitude, λ is the longitude, and κ ∈ K is the associated category. In the following, we define a semantic trail as a list of consecutive check-ins created by the same user within a certain amount of time. This definition is similar to the one of semantic trajectories proposed by Parent et al. [9], but it considers LBSNs instead of GPS data. Definition 3 A semantic trail s ∈ S is a temporally ordered list of check-ins (cid:104)c1, c2, . . . , cn(cid:105) created by a particular user υ ∈ U, i.e., for each i, ci = (νi, υ, τi) where τi < τi+1 ∧ νi (cid:54)= νi+1. In order to construct the semantic trails from the initial datasets, we processed the check-ins and we ana- lyzed their timestamps, for obtaining an unambiguous time representation that also includes the time zone. To this end, we exploited the ciso8601 Python library.5 Then, we grouped the check-ins by user and we sorted them according to their timestamp. From such ordered lists of check-ins we constructed the semantic 3 https://github.com/D2KLab/semantic-trails 4 https://developer.foursquare.com/docs/resources/ categories 5 https://github.com/closeio/ciso8601 trails by assuming that two check-ins that are not dis- tant in time more than eight hours belong to the same trail, similarly to what has been done in [2]. In Algorithm 1, we list the procedure for creating the set S, given the set of users U, the set of check-ins C, and the time interval δτ = 8 hours. Please note that some check-ins will not be included in any trail because they are too distant in time and, therefore, they will not be part of the STDs. if τi < τi−1 + δτ then Algorithm 1 Generation of the set S. Require: U (cid:54)= {∅} ∧ C (cid:54)= {∅} ∧ δτ = τi − τj . 1: S ← {∅} 2: for all υ ∈ U do s ← ∅ 3: for all ci ∈ Cυ : τi−1 < τi ∧ i > 1 do 4: 5: 6: 7: 8: 9: 10: 11: 12: 13: 14: 15: end if 16: end for 17: end for 18: return S if s is ∅ then s ← (cid:104)ci−1(cid:105) end if s ← s + (cid:104)ci(cid:105) if not s is ∅ then else S ← S ∪ {s} s ← ∅ end if In addition to this algorithm, we applied three dif- ferent filters before constructing the trails in order to re- move suspicious check-ins, that may have been spoofed with the help of automated software. We first ignored the check-ins performed by a cer- tain user in the same POI multiple times in a row and we only considered the last one, because such repeti- tions cannot result in meaningful semantic trails. Then, we discarded the check-ins performed by the same user in less than one minute, as it is unreasonable to visit a venue in such a short amount of time. Finally, we filtered out the check-ins that require an unrealistic speed for moving from a certain venue to the next one. In particular, we removed consecutive check- ins that are associated with a speed greater than Mach 1 (∼ 343 m/s), as this value is higher than the normal cruise speed of an airplane. We computed the distance between two venues by applying the haversine formula to their geographical coordinates [13]. This approach is similar to the one followed in [15]. 4 Diego Monti et al. 3.2 Semantic Enrichment Table 1: The fields available in the STDs. In order to enrich the available datasets, we identified the city where each venue is probably located by per- forming the reverse geocoding of its coordinates. To this purpose, we used the reverse geocoder Python li- brary6 and the geographical coordinates of all the cities with a population greater than 500 people or seat of a fourth-order administrative division as reported by GeoNames. We also obtained the corresponding entities from Wikidata and we included their URIs, if available, in the STDs by matching the English city names and the geographical coordinates, when their distance was less than 10 km. We were able to find a correspondence for the 84% of the cities available in GeoNames. Furthermore, we manually mapped the categories listed in the Foursquare taxonomy with the Schema.org vocabulary. If a Foursquare category cannot be mapped with a leaf, then we mapped it with an ancestor. The mapping has involved three domain experts who per- formed a two-stage process: the first has involved two experts and it has elicited mappings and doubts, the second has involved the three experts whose the one excluded from the first stage acted as meta-reviewer, validating the mappings and resolving inconsistencies by answering to doubts. The resulting mapping is avail- able in our GitHub repository.7 In the STDs, we in- cluded both the original Foursquare category and the associated Schema.org entity for each venue. 3.3 Output Formats The final result of the aforementioned process is avail- able in two different file formats. The first one is a comma-separated values file containing the fields de- tailed in Table 1. The second one is an equivalent RDF Turtle version of the dataset. The Foursquare user identifier has been anonymized by replacing it with a number. On the other hand, the identifier of the venue corresponds to its Foursquare URI and, therefore, it can be used to retrieve additional information. For each check-in we also provide the cat- egory of the venue as available in the Foursquare tax- onomy and the corresponding Schema.org term. The GeoNames identifier corresponds to the city in which the venue is located, while the country code refers to the country associated with that city. Finally, the times- tamp is expressed in the ISO 8601 format and it has been approximated, for privacy reasons, to the minute. 6 https://github.com/thampiman/reverse-geocoder 7 https://github.com/D2KLab/semantic-trails/blob/ master/mapping.csv Field Description The numeric identifier of the trail The numeric identifier of the user The Foursquare identifier of the venue The Foursquare identifier of the category The Schema identifier of the category The GeoNames identifier of the city The Wikidata identifier of the city trail id user id venue id venue category venue schema venue geonames venue wikidata venue city name The name of the city venue country timestamp The code of the country The timestamp of the check-in As an example of the CSV format, we report two semantic trails in Listing 1. Listing 1: The first two trails obtained from the GSCD. trail_id , user_id , venue_id , venue_category , 1 ,1 , 4 e 7 5 3 d b 3 c 6 5 b b 9 1 d b 4 4 9 3 d 7 8 , (cid:44)→ venue_schema , venue_geonames , (cid:44)→ venue_wikidata , v en u e _c i ty _ n am e , (cid:44)→ venue_country , t i m e s t a m p 1 ,1 , 4 e c 6 5 6 2 0 7 e e 5 3 7 d a 7 d 2 2 0 f 9 1 , (cid:44)→ 4 b f 5 8 d d 8 d 4 8 9 8 8 d 1 6 2 9 4 1 7 3 5 , schema:Place , (cid:44)→ g e o n a m e s : 5 1 2 5 7 3 4 , wd:Q3449083 , Malverne , US (cid:44)→ , 2 0 1 2 - 0 4 - 0 3 T 1 8 : 1 9 : 0 0 - 0 4 : 0 0 (cid:44)→ 4 b f 5 8 d d 8 d 4 8 9 8 8 d 1 1 6 9 4 1 7 3 5 , s ch e m a: B ar O r Pu b (cid:44)→ , g e o n a m e s : 5 1 1 7 8 9 1 , wd:Q3452120 , F r a n k l i n (cid:44)→ Square , US , 2 0 1 2 - 0 4 - 0 4 T 0 0 : 1 5 : 0 0 - 0 4 : 0 0 (cid:44)→ 4 b f 5 8 d d 8 d 4 8 9 8 8 d 1 0 1 9 5 1 7 3 5 , schema:Store , (cid:44)→ g e o n a m e s : 5 1 2 5 7 3 4 , wd:Q3449083 , Malverne , US (cid:44)→ , 2 0 1 2 - 0 4 - 0 7 T 1 2 : 4 0 : 0 0 - 0 4 : 0 0 (cid:44)→ 4 b f 5 8 d d 8 d 4 8 9 8 8 d 1 3 4 9 4 1 7 3 5 , (cid:44)→ s c h e m a : P e r f o r m i n g A r t s T h e a t e r , (cid:44)→ g e o n a m e s : 5 1 2 5 7 3 4 , wd:Q3449083 , Malverne , US (cid:44)→ , 2 0 1 2 - 0 4 - 0 7 T 1 2 : 4 6 : 0 0 - 0 4 : 0 0 2 ,1 , 4 c c 3 6 d 0 a d 4 3 b a 1 4 3 0 7 1 c 6 0 f 8 , 2 ,1 , 4 e 4 1 8 d d b 8 8 7 7 4 0 a 5 1 b 5 5 7 2 d 6 , 4 Statistical Analysis We generated the STDs starting from two different col- lections of check-ins obtained from the Foursquare plat- form. The first one is the Global-Scale Check-in Dataset (GSCD), created by the authors of [15] and publicly available on the Web. The second one is a similar but more recent set of check-ins realized by the authors of this work, originally collected in the context of [8]. More in detail, we retrieved the check-ins performed by the users of the Foursquare Swarm8 mobile applica- tion and publicly shared on Twitter from the Twitter API. Then, we collected additional information associ- ated with the check-ins, like the venue in which it was performed and its geographical coordinates, thanks to the Foursquare API. 8 https://www.swarmapp.com Semantic Trails of City Explorations: How Do We Live a City 5 Table 2: The number of check-ins, venues, and users, the time interval and the period of collection for the two initial sets of check-ins. GSCD Ours Check-ins Venues Users Time Start End 33,263,631 3,680,126 266,909 532 days 2012-04 2013-09 12,473,360 1,930,452 424,730 382 days 2017-10 2018-10 Table 3: The number of check-ins, trails, venues, users, and cities included in the two STD releases. STD 2013 STD 2018 Check-ins Trails Venues Users Cities 18,587,049 6,103,727 2,847,281 256,339 10,152 11,910,007 4,038,150 1,887,799 399,292 52,011 We report some statistics regarding these initial col- lections of check-ins in Table 2. The GSCD contains more check-ins, as it was collected for an higher num- ber of days in a period of great popularity of LBSNs. On the other end, our dataset is being enriched with new check-ins continuously, therefore we envision future re- leases of the STDs based on a future snapshot of our collection of check-ins. We constructed two different versions of the STDs by applying the procedure described in Section 3 to these initial datasets. The two STD versions are named after the year in which the collection phase ended, that is 2013 for the GSCD and 2018 for the snapshot of our collection of check-ins. We list several statistics regarding the STDs in Ta- ble 3. It is possible to observe that the number of ini- tial check-ins available in the GSCD has been greatly reduced in STD 2013, while it has been only slightly decreased in STD 2018. This result is associated with the different collection protocols of the GSCD and our initial dataset. In fact, we decided to start removing misbehaving users directly during the collection phase, in order to limit the number of calls to the Foursquare API. In details, we discarded users that performed two check-ins in less than a minute for two times, because we identified this as a typical non-human behaviour [8]. The radically different number of cities involved in the semantic trails can also be explained by analyzing the collection protocols. The authors of the GSCD only considered densely populated areas, while we looked for check-ins without applying any geographical filter. The Table 4: The number of check-ins removed because of the different filters that we applied for creating the STDs. The total number of invalid check-ins is not equal to the sum of the different categories because the sets are not disjoint. STD 2013 STD 2018 Venue Time Speed Total 2,381,182 1,627,688 66,796 3,963,133 275,359 96,879 13,021 366,491 differences in the number of trails and venues are con- sistent with the size of the initial dataset. In Table 4, we detail the number of check-ins re- moved because of the different filters during the cre- ation of the STDs. We observe a similar effect of the filters on the two datasets: for instance, the constrain on the repetition of a venue is always the most selec- tive one. However, the number of invalid check-ins is extremely different, because of the various approaches exploited during the collection of the initial check-ins. Furthermore, we analyzed the lengths of the seman- tic trails that we built: the truncated histograms of their distributions are available in Figure 1. We observe that the distributions of the two datasets are similar, even if STD 2013 includes a higher number of trails. The average trail lengths are 3.05 in STD 2013 and 2.95 in STD 2018, while their standard deviations are 2.16 and 1.99 respectively. We also depicted, in Figure 2, the histograms rep- resenting the distributions of time durations, that is the number of time units between the first and the last check-in of a trail. It is interesting to notice that STD 2013 has a higher number of short trails, while STD 2018 contains more trails that have a relatively longer time duration with respect to very short ones. This difference may be explained by the fact that the platform and the behaviour of its users evolved during the years: longtime users may be more willing to share check-ins in a constant way. In order to analyze the check-ins of the two datasets from a spatial point of view, we considered the distri- butions of the number of check-ins for each city. As can be deduced from Figure 3, STD 2013 includes a lower number of cities with less than a hundred check-ins, while STD 2018 contains many cities with a relatively low number of check-ins. This result is also related to the different number of cities available in the datasets as consequence of the initial collection protocol. For these reasons, STD 2018 may be more useful to character- ize globally widespread behaviours, while the focus of STD 2013 is only on densely populated areas. 6 Diego Monti et al. (a) STD 2013 (a) STD 2013 (b) STD 2018 (b) STD 2018 Fig. 1: Histograms representing the distribution of trail lengths. We only considered trails with less than 10 venues due to graphical constraints. The scale of the vertical axis is in millions. We also computed the number of check-ins for each country in the two STDs, which are reported in Ta- ble 5. Some interesting differences emerge from these results: for example, Japan moved from the fifth to the first place in STD 2018, while Brazil was superseded by Malaysia. These observations can be easily explained by considering the different collection protocols and the possible changes in the usage patterns of the Foursquare platform during the years. Furthermore, we investigated the number of check- ins from STD 2018 in the two most popular countries, namely Japan and Turkey, grouped by the Schema.org category of their venue. The purpose of this analysis, whose results are listed in Table 6, is to propose a simple but effective way of characterizing the different human behaviours that are typically associated with a certain culture. From these figures it is possible to observe that Fig. 2: Histograms representing the distribution of trail time duration. We only considered trails lasting less than 24 hours due to graphical constraints. Both axes are represented in a logarithmic scale. The unit of the x axis is seconds. The discontinuity of the curves is caused by the time limit used to build the trails. check-ins performed in train stations are very common in Japan, while in Turkey the most widespread category of venues is coffee shop. In order to demonstrate the usefulness of a semanti- cally annotated dataset, we computed additional statis- tics by also relying on external information obtained from GeoNames. In detail, we downloaded the number of inhabitants of the cities in which the check-is were performed, if available, and we considered the check-ins of small cities separately from the ones of big cities. We define a big city as a city with more than a hundred thousand inhabitants. In Table 7, we list the number of trails and check-ins in the STDs performed in small and big cities, while in Table 8 we report the most frequent venue categories 2345678910Numberofcheckins0.00.51.01.52.02.53.03.5Numberoftrails[M]2345678910Numberofcheckins0.00.51.01.52.0Numberoftrails[M]103104105Trailduration[s]103104105Numberoftrails103104105Trailduration[s]103104105Numberoftrails Semantic Trails of City Explorations: How Do We Live a City 7 Table 5: The five countries with the highest number of check-ins in the two versions of the dataset. (a) STD 2013 Country Check-ins Turkey Brazil USA Malaysia Japan 3,282,073 1,994,148 1,859,310 1,584,552 1,553,603 (b) STD 2018 Country Check-ins Japan Turkey Kuwait Malaysia USA 5,075,916 2,030,934 801,867 764,733 583,445 Table 6: The five Schema.org venue categories with the highest number of check-ins from STD 2018 in Japan and in Turkey. (a) Japan Entity schema:TrainStation schema:Restaurant schema:CivicStructure schema:ConvenienceStore schema:SubwayStation Check-ins 1,198,732 704,782 428,321 152,014 147,659 (b) Turkey Entity Check-ins schema:CafeOrCoffeeShop schema:CivicStructure schema:Restaurant schema:AdministrativeArea schema:FoodEstablishment 371,118 179,997 167,832 152,237 132,183 Table 7: The number of trails and check-ins performed in small and big cities. (a) Small cities Trails Check-ins STD 2013 STD 2018 2,045,440 1,705,937 4,444,930 3,584,304 (b) Big cities Trails Check-ins STD 2013 STD 2018 4,693,791 2,855,417 12,350,172 6,971,715 (a) STD 2013 (b) STD 2018 Fig. 3: Histograms representing the distribution of cities per number of check-ins. We only considered cities with less than a hundred check-ins due to graphical con- straints. The second dataset is more geographically widespread than the first one, as it contains an higher number of cities with a lower number of check-ins. in STD 2018 grouped by the size of the cities. It is interesting to notice that airports are associated with small cities, as they are usually located outside densely populated areas. 5 Tourist Sequence Recommender The rich set of metadata collected in the STDs pro- vides an explicit semantic meaning to users' activities. In fact, venue categories play an important role in POI recommender systems, as they enable to model user in- terests and personalize the recommendations [5]. The concept of trail, as defined previously, exploits the con- cept of temporal correlation that is a cornerstone for generating sequences of activities. In the past years, 020406080100Numberofcheckins0100200300400500Numberofcities020406080100Numberofcheckins02000400060008000100001200014000Numberofcities 8 Diego Monti et al. Table 8: The five Schema.org venue categories associ- ated with the highest number of check-ins performed in small and big cities in STD 2018. (a) Small cities Entity Check-ins schema:CivicStructure schema:Restaurant schema:CafeOrCoffeeShop schema:FoodEstablishment schema:Airport 433,467 372,225 303,209 184,563 171,464 (b) Big cities Entity schema:TrainStation schema:Restaurant schema:CivicStructure schema:CafeOrCoffeeShop schema:ShoppingCenter Check-ins 1,005,890 942,711 497,117 443,195 319,543 little attention has been dedicated to the temporal cor- relations among venue categories in the exploration of a city, which is nonetheless a crucial factor in recom- mending POIs. Take the example of a check-in in an Irish Pub at 8 PM: is the user more likely to continue the evening in a Karaoke Bar or in an Opera House? Better a Chinese Restaurant or an Italian Restaurant for dinner after a City Park in the morning and a History Museum in the afternoon? Note that generating these sequences re- quires an implicit modeling of at least two dimensions: temporal, as certain types of venues are more tempo- rally related than others (e.g. after an Irish Pub, people are more likely to go to Karaoke than to a History Mu- seum), and personal, as venue categories implicitly de- fine a user profile, independently from their order (e.g. Steakhouse and Vegetarian Restaurant do not go fre- quently together). Most of existing studies attempt to model directly sequences of POIs rather than their cat- egories to recommend the next POI to a user. In [8], we presented an approach based on a neural learning model, and more precisely, Recurrent Neural Networks (RNNs), to generate sequences of tourist ac- tivities. The RNNs are trained with the sequential data available in the STDs and the output is expected to be a sequence of categories. The space of possible categories is defined by the Foursquare taxonomy, which classifies venues in a hierarchical taxonomy. In order to initiate the generation process, the neural learning model takes as input a seed, i.e. a category from which the tourist wishes to start his city exploration. Figure 4 illustrates the process of semantic city trail generation. As it can be observed in the figure, the instantiating of places or events (entities) was considered as an integral part of the process and it was issued by querying the 3cixty knowledge base [14]. The impact of such use case was certified by a con- trolled and online experimentation with real users and it proved how impactful the STDs are in terms of mean- ingful resources to learn a model to generate tourist ac- tivity sequences and quality of metadata used to train our neural learning models. 6 Conclusion and Future Work In this work, we introduced the STDs, two datasets con- taining millions of check-ins performed on Foursquare and grouped into semantic trails, that are sequences of temporally neighboring activities. We described the al- gorithm used to generate such trails and we detailed the process followed to enrich the available data. We associ- ated each check-in with the Schema.org term represent- ing the venue category in which it was performed and we also identified the Wikidata entities corresponding to the city and country of the venue. We characterized the two datasets by analyzing them considering differ- ent dimensions and we demonstrated the usefulness of semantically annotated data by relying on external in- formation to compute additional statistics. Finally, we briefly described a possible use case of such datasets, in which we proposed a tourist recommender system trained using the trails available in STD 2018. However, we envision different possible scenarios that could ben- efit from such datasets, for example human behaviour analysis and urban mobility studies. The generation phase brought to further attention three points, namely the complexity of the mapping be- tween Foursquare categories and Schema.org, the diffi- culties in obtaining a comprehensive list of cities, and the possible issues caused by inconsistencies present on Wikidata. We observed that different venue categories are not available on Schema.org: for this reason, they have been associated with the most similar term or with a common ancestor. Furthermore, even if some cate- gories are available, they are not considered as a more specific type of schema:Place or schema:Event, and, therefore, they have been mapped with a general term. For example, schema:CollegeOrUniversity is considered an organization and not a physical place, so universities have been mapped with schema:CivicStructure. How- ever, the mapping available in our GitHub repository is not meant to be final, and other researchers are in- vited to submit pull requests to improve it for future releases of the STDs. We also observed that there is no widespread entity that represents the concept of "city" Semantic Trails of City Explorations: How Do We Live a City 9 Fig. 4: The illustration of the Tourist Sequence Recommender in action: it takes as input a seed and it generates a sequence composed of places and events contextualized according to the city where the tourist is located. on Wikidata. For this reason, we decided to rely on the definition provided by GeoNames, even if it considers some districts and neighborhoods as cities. We initially tried to rely on the DBpedia type dbo:City, but we em- pirically observed an high number of wrong or missing entities. Finally, we are aware of the fact that some URIs representing a city may be erroneous, due to du- plicates or incorrect mappings between Wikidata and GeoNames. However, these problems can be fixed by future releases of our datasets if they are first resolved in the exploited knowledge base. These points will be part of future research activities. References 1. Cheng, C., Yang, H., Lyu, M.R., King, I.: Where you like to go next: Successive point-of-interest recommen- dation. In: Proceedings of the Twenty-Third Interna- tional Joint Conference on Artificial Intelligence, pp. 2605 -- 2611. AAAI (2013). URL https://www.ijcai.org/ Proceedings/13/Papers/384.pdf 2. Choudhury, M.D., Feldman, M., Amer-Yahia, S., Gol- bandi, N., Lempel, R., Yu, C.: Automatic construction of travel itineraries using social breadcrumbs. In: Proceed- ings of the 21st ACM conference on hypertext and hy- permedia. ACM (2010). DOI 10.1145/1810617.1810626 3. Feng, S., Li, X., Zeng, Y., Cong, G., Chee, Y.M., Yuan, Q.: Personalized ranking metric embedding for next new POI recommendation. In: Proceedings of the Twenty- Fourth International Joint Conference on Artificial In- telligence, pp. 2069 -- 2075. AAAI (2015). URL https: //www.ijcai.org/Proceedings/15/Papers/293.pdf 4. Li, Y., Steiner, M., Wang, L., Zhang, Z.L., Bao, J.: Ex- ploring venue popularity in Foursquare. In: 2013 Pro- ceedings IEEE INFOCOM. IEEE (2013). DOI 10.1109/ infcom.2013.6567164 5. Liu, B., Xiong, H.: Point-of-interest recommendation in location based social networks with topic and location awareness. In: Proceedings of the 2013 SIAM Interna- tional Conference on Data Mining, pp. 396 -- 404. Society for Industrial and Applied Mathematics (2013). DOI 10.1137/1.9781611972832.44 6. Monti, D., Palumbo, E., Rizzo, G., Troncy, R., Ehrhart, T., Morisio, M.: Semantic trails datasets (2019). DOI 10. 6084/m9.figshare.7429076.v2. URL https://figshare. com/articles/Semantic_Trails_Datasets/7429076/2 7. Noulas, A., Scellato, S., Mascolo, C., Pontil, M.: Exploit- ing semantic annotations for clustering geographic areas and users in location-based social networks. In: Fifth In- ternational AAAI Conference on Weblogs and Social Me- dia (2011). URL https://www.aaai.org/ocs/index.php/ ICWSM/ICWSM11/paper/view/3845/4388 8. Palumbo, E., Rizzo, G., Troncy, R., Baralis, E.: Predict- ing your next stop-over from location-based social net- work data with recurrent neural networks. In: Proceed- ings of the 2nd Workshop on Recommenders in Tourism co-located with 11th ACM Conference on Recommender Systems, no. 1906 in CEUR Workshop Proceedings, pp. 1 -- 8. CEUR-WS.org (2017). URL http://ceur-ws.org/ Vol-1906/paper1.pdf 9. Parent, C., Spaccapietra, S., Renso, C., Andrienko, G., Andrienko, N., Bogorny, V., Damiani, M.L., Gkoulalas- Divanis, A., Macedo, J., Pelekis, N., Theodoridis, Y., Yan, Z.: Semantic trajectories modeling and analysis. ACM Computing Surveys 45(4), 42:1 -- 42:32 (2013). DOI 10.1145/2501654.2501656 10. Preot¸iuc-Pietro, D., Cranshaw, J., Yano, T.: Exploring venue-based city-to-city similarity measures. In: Pro- ceedings of the 2nd ACM SIGKDD International Work- shop on Urban Computing. ACM (2013). DOI 10.1145/ 2505821.2505832 11. Rizzo, G., Meo, R., Pensa, R.G., Falcone, G., Troncy, R.: Shaping city neighborhoods leveraging crowd sensors. Information Systems 64, 368 -- 378 (2017). DOI 10.1016/ j.is.2016.06.009 12. S´anchez, P., Bellog´ın, A.: A novel approach for venue rec- ommendation using cross-domain techniques. In: Work- shop on Intelligent Recommender Systems by Knowl- edge Transfer and Learning co-located with the 12th ACM Conference on Recommender Systems (2018). URL https://arxiv.org/abs/1809.09864 13. Sinnott, R.W.: Virtues of the haversine. Sky and Tele- scope 68, 159 (1984) Matt is going to visit Picasso Museum in Antibes this afternoonAfter, he can be interested in Taking a beer in an Irish Pub, first: Hop StoreThen, having a dinner in a French Restaurant: Le JardinAnd, lately, attending Jazz à Juan event in a Jazz Clubsequence of venues and events that Matt can be interested to go after having visited Picasso Museum 10 Diego Monti et al. 14. Troncy, R., Rizzo, G., Jameson, A., Corcho, O., Plu, J., Palumbo, E., Hermida, J.C.B., Spirescu, A., Kuhn, K.D., Barbu, C., Rossi, M., Celino, I., Agarwal, R., Scanu, C., Valla, M., Haaker, T.: 3cixty: Building comprehensive knowledge bases for city exploration. Journal of Web Semantics 46-47, 2 -- 13 (2017). DOI 10.1016/j.websem. 2017.07.002 15. Yang, D., Zhang, D., Qu, B.: Participatory cultural mapping based on collective behavior data in location- based social networks. ACM Transactions on Intelli- gent Systems and Technology 7(3), 1 -- 23 (2016). DOI 10.1145/2814575 16. Yang, D., Zhang, D., Yu, Z., Yu, Z.: Fine-grained preference-aware location search leveraging crowdsourced digital footprints from LBSNs. In: Proceedings of the 2013 ACM international joint conference on pervasive and ubiquitous computing. ACM (2013). DOI 10.1145/ 2493432.2493464 17. Yang, D., Zhang, D., Zheng, V.W., Yu, Z.: Modeling user activity preference by leveraging user spatial temporal characteristics in LBSNs. IEEE Transactions on Systems, Man, and Cybernetics: Systems 45(1), 129 -- 142 (2015). DOI 10.1109/tsmc.2014.2327053 18. Ye, J., Zhu, Z., Cheng, H.: What's your next move: User activity prediction in location-based social net- works. In: Proceedings of the 2013 SIAM Interna- tional Conference on Data Mining, pp. 171 -- 179. Society for Industrial and Applied Mathematics (2013). DOI 10.1137/1.9781611972832.19
1509.04098
2
1509
2015-11-10T17:31:40
Fame for sale: efficient detection of fake Twitter followers
[ "cs.SI", "cs.CR", "cs.LG" ]
$\textit{Fake followers}$ are those Twitter accounts specifically created to inflate the number of followers of a target account. Fake followers are dangerous for the social platform and beyond, since they may alter concepts like popularity and influence in the Twittersphere - hence impacting on economy, politics, and society. In this paper, we contribute along different dimensions. First, we review some of the most relevant existing features and rules (proposed by Academia and Media) for anomalous Twitter accounts detection. Second, we create a baseline dataset of verified human and fake follower accounts. Such baseline dataset is publicly available to the scientific community. Then, we exploit the baseline dataset to train a set of machine-learning classifiers built over the reviewed rules and features. Our results show that most of the rules proposed by Media provide unsatisfactory performance in revealing fake followers, while features proposed in the past by Academia for spam detection provide good results. Building on the most promising features, we revise the classifiers both in terms of reduction of overfitting and cost for gathering the data needed to compute the features. The final result is a novel $\textit{Class A}$ classifier, general enough to thwart overfitting, lightweight thanks to the usage of the less costly features, and still able to correctly classify more than 95% of the accounts of the original training set. We ultimately perform an information fusion-based sensitivity analysis, to assess the global sensitivity of each of the features employed by the classifier. The findings reported in this paper, other than being supported by a thorough experimental methodology and interesting on their own, also pave the way for further investigation on the novel issue of fake Twitter followers.
cs.SI
cs
Fame for sale: efficient detection of fake Twitter followers✩ Stefano Crescia,b, Roberto Di Pietrob, Marinella Petrocchia, Angelo Spognardia,1,∗, Maurizio Tesconia aIIT-CNR, Via G. Moruzzi, 1 – 56124 Pisa, Italy bBell Labs, Alcatel-Lucent, Paris, France Abstract Fake followers are those Twitter accounts specifically created to inflate the number of followers of a target account. Fake followers are dangerous for the social platform and beyond, since they may alter concepts like popularity and influence in the Twittersphere—hence impacting on economy, politics, and society. In this paper, we contribute along different dimensions. First, we review some of the most relevant existing features and rules (proposed by Academia and Media) for anomalous Twitter accounts detection. Second, we create a baseline dataset of verified human and fake follower accounts. Such baseline dataset is publicly available to the scientific community. Then, we exploit the baseline dataset to train a set of machine-learning classifiers built over the reviewed rules and features. Our results show that most of the rules proposed by Media provide unsatisfactory performance in revealing fake followers, while features proposed in the past by Academia for spam detection provide good results. Building on the most promising features, we revise the classifiers both in terms of reduction of overfitting and cost for gathering the data needed to compute the features. The final result is a novel Class A classifier, general enough to thwart overfitting, lightweight thanks to the usage of the less costly features, and still able to correctly classify more than 95% of the accounts of the original training set. We ultimately perform an information fusion-based sensitivity analysis, to assess the global sensitivity of each of the features employed by the classifier. The findings reported in this paper, other than being supported by a thorough experimental methodology and interesting on their own, also pave the way for further investigation on the novel issue of fake Twitter followers. Keywords: Twitter, fake followers, anomalous account detection, baseline dataset, machine learning 5 1 0 2 v o N 0 1 ] I S . s c [ 2 v 8 9 0 4 0 . 9 0 5 1 : v i X r a ✩ An extended version of this preprint has been accepted for publication on Elsevier’s journal Decision Support Systems http:// dx.doi.org/ 10.1016/ j.dss.2015.09.003 . Please, cite this work as: “Cresci, S., Di Pietro, R., Petrocchi, M., Spognardi, A., & Tesconi, M. (2015). Fame for sale: Efficient detection of fake Twitter followers. Decision Support Systems, 80, 56-71”. ∗Corresponding author Email addresses: [email protected] (Stefano Cresci), [email protected] (Roberto Di Pietro), [email protected] (Marinella Petrocchi), [email protected] (Angelo Spognardi), [email protected] (Maurizio Tesconi) 1Phone number: +39 050 315 3376 Preprint submitted to Elsevier November 11, 2015 1. Introduction Originally started as a personal microblogging site, Twitter has been transformed by common use to an information publishing venue. Statistics reported about a billion of Twitter subscribers, with 302 million monthly active users2. Twitter annual advertising revenue in 2014 has been estimated to around $480 million3. Popular public characters, such as actors and singers, as well as traditional mass media (radio, TV, and newspapers) use Twitter as a new media channel. Such a versatility and spread of use have made Twitter the ideal arena for proliferation of anomalous accounts, that behave in unconventional ways. Academia has mostly focused its attention on spammers, those accounts actively putting their efforts in spreading malware, sending spam, and advertising activities of doubtful legality [1, 2, 3, 4]. To enhance their effectiveness, these malicious accounts are often armed with automated twitting programs, as stealthy as to mimic real users, known as bots. In the recent past, media have started reporting that the accounts of politicians, celebrities, and popular brands featured a suspicious inflation of followers4. So-called fake followers correspond to Twitter accounts specifically exploited to increase the number of followers of a target account. As an example, during the 2012 US election campaign, the Twitter account of challenger Romney experienced a sudden jump in the number of followers. The great majority of them has been later claimed to be fake5. Similarly, before the last general Italian elections (February 2013), online blogs and newspapers had reported statistical data over a supposed percentage of fake followers of major candidates6. At a first glance, acquiring fake followers could seem a practice limited to foster one’s vanity—a maybe questionable, but harmless practice. However, artificially inflating the number of followers can also be finalized to make an account more trustworthy and influential, in order to stand from the crowd and to attract other genuine followers [5]. Recently, banks and financial institutions in U.S. have started to analyze Twitter and Facebook accounts of loan applicants, before actually granting the loan7. Thus, to have a “popular” profile can definitely help to augment the creditworthiness of the applicant. Similarly, if the practice of buying fake followers is adopted by malicious accounts, as spammers, it can act as a way to post more authoritative messages and launch more effective advertising campaigns [6]. Fake followers detection seems to be an easy task for many bloggers, that suggest their “golden rules” and provide a series of criteria to be used as red flags to classify a Twitter account behavior. However, such rules are 2C. Smith, By The Numbers: 150+ Amazing Twitter Statistics, http://goo.gl/o1lNi8 - June 2015. Last checked: July 23, 2015. 3Statistic Brain, Twitter statistics, http://goo.gl/XEXB1 - March 2015. Last checked: July 23, 2015. 4Corriere Della Sera (online ed.), Academic Claims 54% of Grillo’s Twitter Followers are Bogus, http://goo.gl/qi7Hq - July 2012. Last checked: July 23, 2015. 5New York Times (online ed.), Buying Their Way to Twitter Fame, http://goo.gl/VLrVK, - August 2012. Last checked: July 23, 2015. 6The Telegraph (online ed.), Human or bot? Doubts over Italian comic Beppe Grillo’s Twitter followers, http://goo.gl/2yEgT - July 2012. Last checked: July 23, 2015. 7Le Monde (online ed.), Dis-moi combien d’amis tu as sur Facebook, je te dirai si ta banque va t’accorder un pret, http://goo.gl/zN3PJX - Sept. 2013. Last checked: July 23, 2015. 2 usually paired neither with analytic algorithms to aggregate them, nor with validation mechanisms. As for Academia, researchers have focused mainly on spam and bot detection, with brilliant results characterizing Twitter accounts based on their (non-)human features, mainly by means of machine-learning classifiers trained over manually annotated sets of accounts. To the best of our knowledge, however, despite fake followers constitute a widespread phenomenon with both economical and social impacts, in the literature the topic has not been deeply investigated yet. Contributions The goal of this work is to shed light on the phenomenon of fake Twitter followers, aiming at overcoming current limitations in their characterization and detection. In particular, we provide the following contribu- tions. First, we build a baseline dataset of Twitter accounts where humans and fake followers are known a priori. Second, we test known methodologies for bot and spam detection on our baseline dataset. In partic- ular, we test the Twitter accounts in our reference set against algorithms based on: (i) single classification rules proposed by bloggers, and (ii) feature sets proposed in the literature for detecting spammers. The results of the analysis suggest that fake followers detection deserves specialized mechanisms: specifically, algorithms based on classification rules do not succeed in detecting the fake followers in our baseline dataset. Instead, classifiers based on features sets for spambot detection work quite well also for fake followers de- tection. Third, we classify all the investigated rules and features based on the cost required for gathering the data needed to compute them. Building on theoretical calculations and empirical evaluations, we show how the best performing features are also the most costly ones. The novel results of our analysis show that data acquisition cost often poses a serious limitation to the practical applicability of such features. Finally, building on the crawling cost analysis, we design and implement lightweight classifiers that make use of the less costly features, while still being able to correctly classify more than 95% of the accounts of our training dataset. In addition, we also validated the detection performances of our classifiers over two other sets of human and fake follower accounts, disjoint from the original training dataset. Road map The remainder of this paper is structured as follows. Section 2 considers and compares related work in the area of Twitter spam and bot detection. Section 3 describes our baseline dataset. In Section 4, we evaluated a set of criteria for fake Twitter followers detection promoted by Social Media analysts using our baseline dataset. In Section 5, we examine features used in previous works for spam detection of Twitter accounts. In Section 6 we compute the cost for extracting the features our classifiers are based on. A lightweight and efficient classifier is also provided, attaining a good balance between fake followers detection capability and crawling cost. Finally, Section 7 concludes the paper. 3 2. Related Work Quoting from [7], “A fake Twitter account is considered as one form of deception (i.e., deception in both the content and the personal information of the profiles as well as deception in having the profile follow others not because of personal interest but because they get paid to do so).” The second characterization for deception is exactly the one we deal with in our paper. We specifically consider fake followers as those Twitter accounts appropriately created and sold to customers, which aim at magnifying their influence and engagement to the eyes of the world, with the illusion of a big number of followers. So defined fake followers are only an example of anomalous accounts which are spreading over Twitter. Anomalies have been indeed identified in the literature as either spammers (i.e. accounts that advertise unsolicited and often harmful content, containing links to malicious pages [8]), or bots (i.e., computer programs that control social accounts, as stealthy as to mimic real users [9]), or cyborgs (i.e., accounts that interweave characteristics of both manual and automated behavior [10]). Finally, there are fake followers, accounts massively created to follow a target account and that can be bought from online accounts markets. 2.1. Grey literature and Online Blogs Before covering the academic literature, we briefly report on online documentation that presents a series of intuitive fake follower detection criteria, though not proved to be effective in a scientific way. The reason why we cite this work is twofold: on the one hand, online articles and posts testify the quest for a correct discrimination between genuine and fake Twitter followers; on the other hand, we aim at assessing in a scientific manner whether such criteria could actually be employed for fake followers detection. As an example, a well-known blogger in [11] indicates as possible bots-like distinctive signals the fact that bots accounts: 1) have usually a huge amount of following and a small amount of followers; 2) tweet the same thing to everybody; and, 3) play the follow/unfollow game, i.e. they follow and then unfollow an account usually within 24 hours. Criteria advertised by online blogs are mainly based on common sense and the authors usually do not even suggest how to validate them. A series of reports published by the firm Digital evaluations [12] have attracted the attention of Italian and European newspapers and magazines, raising doubts on the Twitter popularity of politicians and leading international companies. A number of criteria, inspired by common sense and denoting human behavior, are listed in the reports and used to evaluate a sample of the followers of selected accounts. For each criterion satisfied by a follower, a human score is assigned. For each not fulfilled criterion, either a bot or neutral score is assigned. According to the total score, Twitter followers are classified either as humans, as bots or as neutral (in the latter case, there is not enough information to assess their nature), providing a quality score of the effective influence of the followed account. The results in [12], however, lack a validation phase. Finally, some companies specialized in social media analysis offer online services to estimate how much a Twitter account is genuine in terms of its followers [13, 14, 15]. However, the criteria used for the 4 analysis are not publicly disclosed and just partially deductible from information available on their web sites. Moreover, as demonstrated in our previous work [16], these analyses are affected by several biases like small and statistically unsound sampling strategies. 2.2. Academic literature In recent years, spam detection on Twitter has been the matter of many investigations, approaching the issue from several points of view. As an example, a branch of research focused on the textual content of tweets [4, 3, 17], studying the redirection of embedded URLs in tweets [18], and classifying the URLs landing pages [19]. Other works tackled the problem of deception on Twitter via epistemology. For instance, in [20] authors evaluate 4 epistemological features for the task of deception detection: authority, plausibility and support, independent corroboration, and presentation. Work in [21] overcomes the limitation of not being able to correctly label those tweets without URLs as spam tweets, by proposing a composite tool, able to match incoming tweets with underlying templates commonly used by spammers. Instead of considering the content of tweets, work in [7] tries to classify if an account can be trusted or not based on possibly inconsistent information originating from the profile of the account only. A series of works investigate spammers on microblogging platforms through a multi-feature approach, including features on the profile, the behavior, and the timeline of an account. Within this research line, we cite here [8], [2], and [22]. The work in [8] presents an analysis on how spammers operate on Facebook, Twitter, and MySpace, reporting that the suspicious accounts shared some common traits on specific fea- tures. Those served as input to a machine learning-based classifier [23] leading to the detection of more than 15,000 spam profiles, that Twitter promptly deleted. In [2], the authors propose a taxonomy of cri- teria for detecting Twitter spammers. A series of experiments show how the newly designed criteria have higher detection rates, when compared to the existing ones. In [22], the authors leverage a combination of behavioral features (such as tweeting and retweeting activities), network features (such as the number of an account’s followers and friends), and content-based features to develop a hybrid mathematical model for spammer detection in Weibo, the Chinese microblogging site resembling Twitter. The authors of [10] classify Twitter accounts in three classes: humans, bot, and cyborgs. The latter class represents either bot-assisted humans or human-assisted bots. The authors used a decision maker based on three specialized components that considered the content and timing of tweets and some account properties. The algorithms proposed in [24, 4] aim at spotting groups of automated malicious Twitter accounts as quickly as possible, to avoid the accounts’ owners from taking advantage of them.Thus, authors apply clustering algorithms to group accounts created within a short period of time, considering, among others, name- and content-based features. In [25], the authors list several criteria to detect clients and victims of Twitter account markets, that are 5 online services offering their subscribers to provide followers in exchange for a fee, and to spread promotional tweets on their behalf. In another work [26], the same research team provides more details about the account markets, analyzing additional properties and characteristics of their customers (e.g., the dynamics of followers and friends and the ability of generating engagement), and providing a classifier for the detection of both markets and market customers. The authors of [27] monitor prices, availability, and fraud perpetrated by a set of merchants of Twitter accounts over the course of a ten-months period. Such a research is a spotlight on techniques and methodologies that accounts markets exploit to create and register fraudulent accounts, from CAPTCHA solving services, to deceitful email credentials and a diverse pool of IP addresses to evade blacklisting. In collaboration with Twitter itself, the authors developed a classifier to detect such fraudulent accounts, which were consequently suspended. It is worth noting that the cited selection of academic works is not exhaustive. However, it considers a huge collection of criteria, which we further leverage for our approach to fake Twitter followers detection. There are other works for spam detection, not detailed here, like [1, 28, 29, 30, 31, 32], which base their results on subsets, or on slightly modified versions, of criteria considered by the selected set of related work. 2.3. Differences and similarities with our approach The goal of our research is the automatic detection of those Twitter accounts specifically created to inflate the number of followers of some target account (so called fake Twitter followers). A priori, both spammers, bots, and genuine users’ accounts could fall in the macro-category of fake followers, and specific features already proved effective in the literature for spotting spammers and bots could work also in the case of fake followers. It was indeed this observation that initially drove the authors of this paper towards the direction of testing rules and features from past works on a reference dataset of genuine accounts and fake followers. This contributed to prune those rules and features that behaved worst in detecting fake followers, and leave the ones that well behave. From a technical point of view, in our experiments we rely on machine learning-based classifiers exploiting features of 1) profile, 2) activity, and 3) relationships of the accounts, similarly to [8, 2]. Instead, we do not rely on features inherent to specific contents of tweets, such as the presence of URLs and the semantics of the text [17, 19]. We move beyond the mere application of already tested features to a new dataset, since we revise our classifiers to reduce overfitting and cost for data gathering, as illustrated in Sections 5 and 6. Finally, similarly to [26], we bought fake Twitter followers from different markets available on the Web. We conducted such an exercise independently from [26] and, moreover, goals of the two works are quite different, ours focusing on accounts sold by these markets, while the other targeting their customers. As for the genuine part of our baseline dataset, we recruit accounts of people that have voluntarily adhered to our campaign, and leverage a dataset of annotated accounts, belonging to people active on Twitter within a particular period of time on a specific domain, and whose authenticity has been verified. However, willing 6 to test our classifiers over a representative sample of the entire Twitter population, we also approach the construction of a test set by randomly picking: 1) a sample of Barack Obama’s followers, and 2) a sample of the Twitter population. 3. Baseline datasets In this section we present the datasets of Twitter accounts used to conduct our empirical study throughout the paper. We detail how we collected each of them and how we verified if they were genuine humans or fake followers. Despite the final size of the baseline dataset, to perform our research, we altogether crawled 9 millions of Twitter accounts and about 3 millions of tweets. To foster investigation on the novel issue of fake Twitter followers, our baseline dataset has been made publicly available for research purposes [33]. 3.1. The Fake Project The Fake Project started its activities on December 12, 2012, with the creation of the Twitter account @TheFakeProject. Its profile reports the following motto: “Follow me only if you are NOT a fake” and explains that the initiative is linked with a research project owned by researchers at IIT-CNR, in Pisa-Italy. In a first phase, the owners contacted further researchers and journalists to advertise the initiative and also foreign journalists and bloggers supported the initiative in their countries. In a twelve days period (Dec 12-24, 2012), the account has been followed by 574 followers. Through the Twitter APIs, we crawled a series of public information about these followers together with that of their followers and followings. For this dataset, we crawled the 574 accounts, leading to the collection of 616,193 tweets and 971,649 relationships (namely, linked Twitter accounts). All those followers voluntarily joined the project. To include them in our reference set of humans, we also launched a verification phase. Each follower received a direct message on Twitter from @TheFakeProject, containing an URL to a CAPTCHA, unique for each follower. We consider as “certified humans” all the 469 accounts out of the 574 followers that successfully completed the CAPTCHA. In the remainder of this section this dataset is referred to as TFP. 3.2. #elezioni2013 dataset The #elezioni2013 dataset, henceforth E13 , was born to support a research initiative for a sociological study carried out in collaboration with the University of Perugia and the Sapienza University of Rome. The study focused on the strategic changes in the Italian political panorama for the 3-year period 2013-2015. Researchers identified 84,033 unique Twitter accounts that used the hashtag #elezioni2013 in their tweets, during the period between January 9 and February 28, 2013. Identification of these accounts has been based on specific keyword-driven queries on the username and biography fields of the accounts’ profiles. Keywords include blogger, journalist, social media strategist/analyst, and congressperson. Specific names of political parties have been also searched. In conclusion, all the accounts belonging to politicians and candidates, 7 parties, journalists, bloggers, specific associations and groups, and whoever somehow was officially involved in politics, have been discarded. The remaining accounts (about 40k) have been classified as citizens. This last set has been sampled (with confidence level 95% and confidence interval 2.5), leading to a final set of 1488 accounts, that have been subject to a manual verification to determine the nature of their profiles and tweets. The manual verification process has been carried out by two sociologists from the University of Perugia, Italy. It involved the analysis of profile pictures, biographies, and timeline of the accounts under investigation. Accounts not having a biography or a profile picture have been discarded. URLs in biographies have also been manually checked to allow for a deeper analysis of the subject. Only accounts labeled as humans by both the sociologists have been included in the E13 dataset. Overall, the manual verification phase lasted roughly two months. As a result, 1481 accounts became part of dataset E13 . 3.3. Baseline dataset of human accounts The above introduced datasets form our final set, labeled HUM , of 1950 verified human accounts. It is worth noting how the two subsets differ from each other. The TFP set consists of accounts that have been recruited on a volunteer base: people involved in the initiative aimed to be part of an academic study for discovering fake followers on Twitter, and are a mixture of researchers and social media experts and journalists, mostly from Italy, but also from US and other European countries. The E13 set consists of particularly active Italian Twitter users, with different professional background and belonging to diverse social classes, sharing a common interest for politics, but that do not belong to the following categories: politicians, parties, journalists, bloggers. 3.4. Baseline dataset of fake followers In April, 2013, we bought 3000 fake accounts from three different Twitter online markets. In particular, we bought 1000 fake accounts from http:// fastfollowerz.com , 1000 from http:// intertwitter.com, and 1000 fake accounts from http:// twittertechnology.com , at a price of $19, $14 and $13 respectively. Surprisingly, fastfollowerz and intertwitter gave us a few more accounts than what we paid for, respectively 1169 and 1337 instead of 1000. We crawled all these accounts to build a fastfollowerz dataset, labeled FSF , and an intertwitter dataset labeled INT . Instead, we were unable to crawl all the 1000 fake followers bought from twittertechnology since 155 of them got suspended almost immediately. The remaining 845 accounts constitute the twittertechnology dataset, which is labeled TWT . We acknowledge that our fake followers dataset is just illustrative, and not exhaustive, of all the possible existing sets of fake followers. However, it is worth noting that we found the Twitter accounts marketplaces by simply Web searching them on the most common search engines. Thus, we can argue that our dataset represents what was easily possible to find on the Web at the time of searching. 8 dataset accounts tweets followers friends total relationships TFP (@TheFakeProject) E13 (#elezioni2013) FSF (fastfollowerz ) INT (intertwitter ) TWT (twittertechnology) HUM (human dataset) FAK (fake dataset) 469 1481 1169 1337 845 1950 1950 563,693 2,068,037 22,910 58,925 114,192 258,494 1,526,944 11,893 23,173 28,588 2,631,730 118,327 1,785,438 34,553 241,710 667,225 253,026 517,485 729,839 908,935 879,580 500,204 2,194,169 264,919 540,658 758,427 2,694,373 914,133 BAS (baseline dataset: HUM ∪ FAK ) 3900 2,750,057 1,819,991 1,788,515 3,608,506 Table 1: Statistics about total collected data [33]. 3.5. Baseline dataset of fake followers and human accounts The final baseline dataset exploited in our experiments is composed of both fake and human profiles. In the following, we briefly discuss the distribution between fake and human accounts that has been chosen for this dataset. Many machine-learning techniques are affected by the imbalance of the natural distributions of the minority and majority classes. This is why, for example, works in the literature have studied how the decision tree-based techniques perform when varying the distribution of the training set. In particular, Weiss and Provost, in [34], considered the performances of decision-tree based classifiers to predict the samples of 26 different datasets, with different distributions between the minority and majority classes. The conclusions of their investigation have shown that the metric used to evaluate the performance of the different classifiers changes the optimal distribution of the classes for the training set. For example, after their empirical analysis, using accuracy as evaluation metric, 9 out of the 26 datasets have the optimal distribution very different from the natural one, while, when using the AUC as evaluation metric, this number grows to 14 out of the 26. Moreover, the optimal distribution has an oversampling of the minority class (there are also cases when the best classifier is obtained with an oversampling up to 90% of the minority class samples). Here, we face another fundamental issue: we do not precisely know the real (natural) distribution of fake followers and human accounts. In 2013, the Twitter staff conjectured that the number of “false or spam accounts should represent less than 5% of our MAUs” (where MAUs refer to monthly active users) [35]. However, MAUs can be assimilated neither to a random sample of Twitter accounts nor to the followers of a given account. Moreover, if an account has bought fake followers, then its distribution of fake followers and human followers can vary dramatically from the natural distribution that one can find, either among MAUs, or among all the Twitter accounts in the Twittersphere. In conclusion, the estimation of 5% as false or spam accounts, in the whole Twitter, can not be directly extended to the fake followers of a given account. Although Twitter has never disclosed the total number of registered users, unofficial sources claim that the Twitter accounts created up to date are many more than the MAUs. This is why we made a conservative assumption, considering a balanced distribution of fake followers and human followers as our baseline dataset. 9 To validate this assumption, we performed the experiments in [34] to our dataset. We progressively varied the class distribution of fake followers and human followers in the dataset, from 5%–95% to 95%–5% (respectively 100 humans–1900 fake followers, 1900 humans–100 fake followers), and used the obtained dataset to train J48 classifiers, considering their performances with cross-validation. The trained classifiers obtained their best results on a balanced distribution of humans and fake followers. To obtain a balanced dataset, we randomly undersampled the total set of fake accounts (i.e., 3351) to match the size of the HUM dataset of verified human accounts. Thus, we built a baseline dataset of 1950 fake followers, labeled FAK . The final baseline dataset for this work includes both the HUM dataset and the FAK dataset for a total of 3900 Twitter accounts. This balanced dataset is labeled BAS in the remainder of the paper and has been exploited for all the experiments described in this work (where not otherwise specified). Table 1 shows the number of accounts, tweets and relationships contained in the datasets described in this section. 4. Fake detection with algorithms based on classification rules In this section, we detail three procedures, originally proposed by bloggers and social media analysts, explicitly conceived for fake followers and bot accounts detection. These proposals were introduced in [12, 11, 14]. The work we focus on in this section is not directly attributable to academic work. However, it is an example of the spreading interest on the phenomenon of fake Twitter followers by Media and Social Marketing companies. Although we do not expect these proposals to satisfactorily perform for the complex task of fake followers detection, we believe a thorough analysis of the proposed criteria could still provide some useful insights. Coincidentally, all the procedures are proposed as algorithms relying on a list of rules, or criteria: each account to be classified is checked against all the rules and the outputs of the checks must be combined together in order to obtain the final classification. Unfortunately in many cases, details on how to combine the criteria to obtain the final classification of an account is not publicly available. Details on how aggregation has been performed are provided in [12] only. Driven by the provided details, we implement the full algorithm described in [12] and we present its detection performances in Section 4.5. In addition, for each of the procedures, we report the criteria as indicated by the original sources and we further specify how we have implemented them into rules suitable to be applied over our datasets. We also detail the reasons for our implementation choices. In this section, we mainly focus on the application of each single rule over our dataset to assess its strength (or weakness) in discriminating fake followers. In Section 6, we combine all the rules together with the features analyzed in Section 5, to assess their collective classification power. This is because a single rule – or feature – alone may not perform well in classifying fake and human accounts, but it may improve the detection if used in combination with other ones. Indeed, it is worth noting that some of the criteria analyzed in this section have been actually exploited by the classifiers built in Section 6. 10 1. the profile contains a name; 2. the profile contains an image; 3. the profile contains a physical address; 4. the profile contains a biography; 5. the account has at least 30 followers; 6. it has been inserted in a list by other Twitter users; 7. it has written at least 50 tweets; 8. the account has been geo-localized; 9. the profile contains a URL; 10. it has been included in another user’s favorites; 11. it writes tweets that have punctuation; 12. it has used a hashtag in at least one tweet; 13. it has logged into Twitter using an iPhone; 14. it has logged into Twitter using an Android device; 15. it is connected with Foursquare; 16. it is connected with Instagram; 17. it has logged into twitter.com website; 18. it has written the userID of another user in at least one tweet, that is it posted a @reply or a mention; 19. (2*number followers) ≥ (number of friends); 20. it publishes content which does not just contain URLs; 21. at least one of its tweets has been retwitted by other accounts (worth 2 points); 22. it has logged into Twitter through different clients (worth 3 points). Table 2: Camisani-Calzolari rule set. Throughout the sequel of the paper we use the term “friends” to denote the users followed by an account (i.e., if A follows B, B is a friend of A). 4.1. Followers of political candidates Camisani-Calzolari [12] carried out a series of tests over samples of Twitter followers of Romney and Obama, for the last US presidential elections, as well as for popular Italian politicians. In [12] it is detailed an algorithm to evaluate an account based on some of its public features. The cited algorithm has enough details to be reproducible: it assigns human/active and bot/inactive scores and classifies an account considering the gap between the sum of the two scores. In particular, the algorithm assigns to the examined accounts 1 (or more, where specified) human point for each of the criteria in Table 2. Moreover, the account receives 2 bot points if it only uses APIs. Finally, for each criterion that fails to be verified, the account receives 1 bot point, with the exception of criteria 8, 13, 14, 15, 16 and 17: in this cases, no bot points are assigned. To verify those rules, we referred to the source metadata of the tweets, that contains a different value representing the platform used to post a tweet. In particular, concerning the above rules, we considered the source metadata with the values iphone, android, foursquare, instagram and web, respectively, and we assigned 1 human point for each of the values found at least once within the collected tweets of the account. For the criterion 21, 2 bot points are assigned if no tweets of the account have been retweeted by other users. Considering rule 8, geo-localization is related to tweets. Consequently, we set this rule as satisfied when at least one tweet of the account has been geo-localized. For the rule 11, punctuation has been searched in both the profile biography and in its timeline. 4.2. Stateofsearch.com Among the several bloggers that propose their golden rules to identify suspicious Twitter accounts, we consider the “7 signals to look out for recognizing Twitter bots”, according to the founder of the social media website stateofsearch.com [11]. The “7 signals to look out for” to recognize Twitter bots are listed in Table 3. 11 1. the biography of the profile clearly specifies that it is a bot account; 2. the friends followers ratio is in the order of 100:1; 3. the account tweets the same sentence to many other accounts; 4. different accounts with duplicate profile pictures are suspicious; 5. accounts that tweet from API are suspicious; 6. the response time (follow → reply) to tweets of other ac- counts is within milliseconds; 7. within a temporal arc of 24 hours. the account tends to follow → unfollow other accounts Table 3: Stateofsearch.com rule set. The rule 3 has been implemented considering the tweet as a single unit. We consider the last 20 tweets of each timeline. For the rule 4, we consider the existence of a duplicate profile picture when at least 3 accounts within the dataset have the same profile picture. For the rule 5, we consider as tweets posted from API all those tweets not being posted from the website twitter.com. For rules 6 and 7, when looking for an account’s friends or followers list, Twitter only gives information about the current list, with no details about past friends or followers. Moreover, Twitter does not disclose any temporal data related to the moment a user stared following, or got followed by, another user. This means that the only way to check a user’s follow/unfollow behavior (rule 7) is to continuously monitor full friends and followers complete lists. The same applies with respect to the measurement of the delay experienced when a user follows (and replies to) other users (rule 6). As further detailed in Section 6, the Twitter rate limits in the use of the APIs makes it practically infeasible to monitor friends and followers lists of even a small group of users. Therefore, we did not apply rules 6 and 7 to our datasets, since that would require to continually monitor those accounts. This also means that those rules cannot be used to support an automatic detection process, since they require an interactive process to be evaluated. 4.3. Socialbakers’ FakeFollowerCheck Several companies provide online tools to classify Twitter followers based on their fakeness degree. Here, we consider the “FakeFollowerCheck tool”, by Socialbakers [14]. While the company website provides eight criteria to evaluate the fakeness degree of the followers of a certain account, it omits details on how to combine such criteria to classify the accounts. We contacted their customer service, but we were answered that “how the respective criteria are measured is rather an internal information”. The FakeFollowerCheck tool analyzes the followers of an account and considers them likely fake when the criteria listed in Table 4 are satisfied. For the rule 2, we consider as spam phrases expressions like “diet” or “make money” or “work from home” (both English and Italian translations), as suggested by the website of Socialbakers. 4.4. Evaluation methodology All the criteria detailed above have been applied to the 2 verified human accounts datasets (TFP and E13 ) as well as to all the 3351 fake followers accounts bought from the Twitter account markets (FSF ∪ 12 followers of the account under investigation 1. the ratio friends is 50:1, or more; 2. more than 30% of all the tweets of the account use spam phrases, such as “diet”, “make money” and “work from home”; 3. the same tweets are repeated more than three times, even when posted to different accounts; 4. more than 90% of the account tweets are retweets; 5. more than 90% of the account tweets are links; 6. the account has never tweeted; 7. the account is more than two months old and still has a default profile image; 8. the user did not fill in neither bio nor location and, at the same time, he/she is following more than 100 accounts. Table 4: Socialbakers rule set. INT ∪ TWT ), as described in Section 3. We conducted one experiment for each rule, considering two classes of accounts, the fake followers and the human ones. To summarize the outcomes of each experiment, we considered some evaluation metrics based on four standard indicators, namely: • True Positive (TP): the number of those fake followers recognized by the rule as fake followers; • True Negative (TN): the number of those human followers recognized by the rule as human followers; • False Positive (FP): the number of those human followers recognized by the rule as fake followers; • False Negative (FN): the number of those fake followers recognized by the rule as human followers. The meaning of each indicator is graphically highlighted by the matrix in Table 5 (called the confusion matrix ), where each column represents the instances in the predicted class, while each row represents the instances in the actual class [36]: In order to evaluate the application of each single rule to the accounts in predicted class actual class human fake human fake TN FN FP TP Table 5: Confusion matrix. the baseline dataset, we consider the following standard evaluation metrics: • Accuracy: the proportion of predicted true results (both true positives and true negatives) in the population, that is TP+TN TP+TN+FP+FN ; • Precision: the proportion of predicted positive cases that are indeed real positive, that is TP TP+FP ; • Recall (or also Sensitivity): the proportion of real positive cases that are indeed predicted positive, that is TP TP+FN ; • F-Measure: the harmonic mean of precision and recall, namely 2·precision·recall precision+recall ; 13 • Matthew Correlation Coefficient (MCC from now on) [37]: the estimator of the correlation between the predicted class and the real class of the samples, defined as: TP · TN - FP · F N p(TP+FN)(TP+FP)(TN+FP)(TN+FN) Each of the above measures captures a different aspect of the prediction quality of the samples that belong to the relevant class (the fake followers, in our dataset). Accuracy measures how many samples are correctly identified in both of the classes, but it does not express if the relevant class is better recognized than the other one. Moreover, there are situations where some predictive models perform better than others, even having a lower accuracy [38]. A high Precision indicates that many of the samples identified as relevant are correctly recognized, but it does not give any information about the relevant samples which have not been identified. This information is provided by the Recall metric, that expresses how many samples, in the whole set of relevant samples, have been correctly recognized: a low recall means that many relevant samples are left unidentified. F-Measure and MCC try to convey in one single value the quality of a prediction, combining the other metrics. Furthermore, MCC is considered the unbiased version of the F-Measure, since it uses all the four elements of the confusion matrix [38]. An MCC value close to 1 means that the prediction is really accurate; a value close to 0 means that the prediction is no better than random guess, and a value close to -1 means that the prediction is heavily in disagreement with the real class. Then, we consider as best rules those criteria whose application gives MCC ≥ 0.6, since such rules have the strongest correlation with the typology of the accounts. For completeness, when available, we also report the area-under-the-curve metric (AUC ), that is the area under the Receiver Operating Characteristic (ROC) curve [39]. The latter is the curve that depicts the performance of a classifier considering the percentage of true positive samples compared with the percentage of false positive samples. The AUC is used to summarize ROC curves in a single value: the more the area approaches to 1, the more capable is the classifier. Finally, we also report the Information Gain (I gain) and the Pearson Correlation Coefficient (Pcc). While the Pearson correlation coefficient can detect linear dependencies between a feature and the tar- get class, the information gain considers a more general dependence, leveraging probability densities (or frequencies, in case of discrete variables). More precisely, the information gain is a measure about the in- formativeness of a feature with respect to the predicting class and it is typically adopted to train machine learning classifiers. It can be informally defined as the expected reduction in entropy caused by the knowl- edge of the value of a given attribute [40]. We compute two information gains: I gain about the outcome of the rule and I gain* about the attribute used by the rule. For I gain, a rule based on attribute A can only assume the values 0 (not satisfied) and 1 (satisfied), while for I gain*, the attribute A can assume much heterogeneous values. For example, when evaluating the information gain of the rule “followers ≥ 30”, a sample with 234 followers contributes with value 1 when we compute I gain, and with value 234 when we compute I gain∗. The Pearson correlation coefficient, instead, is a measure of the strength of the linear rela- 14 dataset real humans humans bots neutral TFP (@TheFakeProject) E13 (#elezioni2013) FSF ∪ INT ∪ TWT (100% fake foll.) 469 1481 0 456 1480 2889 3 0 185 10 1 277 outcome Table 6: Camisani-Calzolari algorithm prediction outcome. evaluation metrics algorithm accuracy precision recall F-M. MCC CC algorithm♯ 0.548 0.974 0.062 0.116 0.175 Table 7: Evaluation of Camisani-Calzolari algorithm (CC algorithm) [12]. Training set: BAS (1950 humans and 1950 fake followers). (♯): the CC algorithm classified 163 accounts as neutral. tionship between two random variables X and Y [41, 42]. Again , we compute Pcc, considering the outcome of the satisfaction of the rule (namely: true=1 or false=0) and Pcc*, based on the value assumed by the attribute used to evaluate the rule. Our experiments in the following sections will show that, generally, a rule and the corresponding attribute assume very different values for the information gain and the Pearson correlation coefficient. 4.5. Evaluation of Camisani-Calzolari algorithm The detection algorithm in [12] aggregates the 22 criteria for identifying human and bot behavior, introduced in Section 4.1. The algorithm evaluates every single rule on the account under investigation, and it assigns a positive human score or a negative bot score, according to the output of the rule application. The final outcome depends on the global score obtained by the account: if the result is a score greater than 0, then the account is marked as human; if it is between 0 and -4, it is marked as neutral ; otherwise, it is marked as bot. Table 6 details the results of running the algorithm over the complete dataset, including the FAK set, namely all the bought fake followers accounts. Although obtaining very good results in detecting the real human accounts, the algorithm achieves a poor fake follower account detection. Most of the accounts have been erroneously tagged as humans too, mainly because the fake followers in our dataset have characteristics that easily make them achieve a human score higher than the bot one. The above inability to detect the fake accounts is evident in the results of our second experiment. To evaluate the algorithm, we used it to predict the class of the accounts of our baseline dataset (BAS ), reporting the evaluation of the final prediction in Table 7. As expected, the algorithm has a poor accuracy (very close to 0.5) and a high precision, meaning that the (few) accounts identified as fake are effectively fake. However, it also has a very low recall, meaning that many of the other fake accounts were unidentified as fake. This poor performance is also expressed by a F-Measure close to 0.1 and by the low MCC value. 15 rule description accuracy precision recall F-M. MCC I gain I gain∗ Pcc Pcc∗ evaluation metrics Camisani-Calzolari [12] (satisfaction of rules means human behavior) — 1 0.001 2 0.166 3 0.316 4 5 0.95 0.971 6 0.811 7 0.986 8 0.972 9 0.579 10 11 0.048 0.224 12 0.977 13 0.991 14 0.996 15 0.969 16 0.067 17 18 0.549 0.998 19 0.064 20 0.524 21 22 0.061 profile has name profile has image profile has address profile has biography followers ≥ 30 belongs to a list tweets ≥ 50 geo-localization has URL in profile in favorites uses punctuation in tweets uses hashtags uses iPhone to log in uses Android to log in has connected with Foursquare has connected with Instagram uses the website Twitter.com has tweeted a userID 2*followers ≥ friends tweets do not just contain URLs retwitted tweets ≥ 1 uses different clients to log in 0.5 0.496 0.419 0.621 0.881 0.755 0.865 0.667 0.665 0.738 0.523 0.608 0.705 0.669 0.565 0.683 0.508 0.772 0.721 0.53 0.753 0.524 — 0.095 0.336 0.811 0.834 0.678 0.909 0.602 0.602 0.848 0.979 0.965 0.633 0.603 0.535 0.616 0.572 0.992 0.642 0.947 0.967 0.819 — 0.002 0.222 0.455 0.888 0.799 0.857 0.748 0.743 0.689 0.091 0.364 0.768 0.75 0.696 0.753 0.12 0.707 0.781 0.12 0.679 0.113 Van Den Beld (State of search) [11] (satisfaction of rules means bot behavior) — 1 0.15 2 0.146 3 0.025 4 5 0.2 bot in biography following:followers = 100:1 same sentence to many accounts duplicate profile pictures tweet from API — 1 0.78 0.928 0.017 0.5 0.541 0.438 0.471 0.118 — 0.541 0.438 0.471 0.118 Socialbakers [14] (satisfaction of rules means fake behavior) 1 2 3 4 5 6 7 8 friends:followers ≥ 50:1 tweets spam phrases same tweet ≥ 3 retweets ≥ 90% tweet-links≥ 90% 0 tweets default image after 2 months no bio, no location, friends ≥100 0.581 0.501 0.348 0.499 0.511 0.521 0.496 0.559 0.997 1 0.046 0.452 0.806 0.988 0.095 0.917 0.162 0.003 0.015 0.007 0.03 0.043 0.001 0.131 0.279 0.005 0.023 0.014 0.057 0.083 0.002 0.229 — -0.06 -0.187 0.306 0.768 0.566 0.735 0.434 0.417 0.502 0.151 0.337 0.489 0.442 0.257 0.446 0.036 0.609 0.531 0.167 0.569 0.125 — 0.205 -0.169 -0.146 -0.779 0.296 0.036 -0.407 -0.009 0.084 0.146 -0.06 0.231 0 0.003 0.026 0.072 0.493 0.268 0.439 0.163 0.144 0.195 0.023 0.1 0.202 0.164 0.173 0.06 0.003 0.334 0.26 0.299 0.278 0.018 0 0 0.444 0 0.528 0 0.435 0.166 0 0.006 0.02 0.003 0.004 0 0.003 0.026 0.072 0.525 0.275 0.621 0.166 0.144 0.44 0.63 0.677 0.219 0.176 0.173 0.06 0.347 0.752 0.26 0.673 0.722 0.629 0 0 0.444 0 0.694 0 0.45 0.317 0.478 0.401 0.621 0.003 0.004 0 0.06 0.187 0.306 0.768 0.566 0.735 0.434 0.417 0.502 0.161 0.337 0.489 0.446 0.442 0.258 0.061 0.609 0.531 0.587 0.569 0.144 0 0.006 0.74 0 0.779 0.011 0.719 0.441 0.007 0.087 0.146 0.06 0.079 0 0.06 0.187 0.306 0.045 0.127 0.289 0.188 0.417 0.30 0.58 0.521 0.293 0.242 0.199 0.144 0.374 0.544 0.531 0.403 0.49 0.55 0 0.006 0.74 0 0.505 0.011 0.404 0.284 0.555 0.353 0.289 0.06 0.079 Table 8: Rules evaluation. 4.6. Single rule evaluation In this section, we analyze the effectiveness of each single rule, as designed by the original authors, in order to evaluate which rule can be considered as a good criterion for the detection of fake Twitter followers. Table 8 summarizes the results obtained by the application of each rule introduced in Sections 4.1, 4.2, and 4.3 to our BAS dataset. In Table 8, we highlighted the rules achieving high MCC values. As shown, only three rules obtained a value higher than 0.6, namely: (1) the threshold of at least 30 followers, (2) the threshold of at least 50 tweets, and (3) the use of a userID in at least one tweet. As expected by the definition of MCC, such rules also exhibit a combination of high accuracy, precision, and recall. However, it is worth observing the values for the information gain and the Pearson correlation coefficient. The information gain of the rules (I gain) is always lower than the evaluation of the related attribute I gain*, while this is not true for the Pearson correlation coefficient (Pcc and Pcc* ). Actually, this happens because Pcc evaluates the linear dependency between two variables that assume very similar values, namely the output of the rule and the class, while the Pcc* considers variables with more heterogeneous 16 values. In the first case, indeed, both the variables class and the output can assume only the values 0 and 1: the class can be either 0 (human) or 1 (fake), the rules can output either 0 (false, for example, account does not have more than 50 tweets) or 1 (true, for example, account has more than 50 tweets). Instead, for the Pcc* , the attribute of a rule (in the example, the number of tweets) can assume much higher values (account has 234 tweets). This is clearly not linearly dependent on the class values, resulting in lower values for the Pcc* with respect to the Pcc [41]. Thus, for each rule listed in Section 4.1 (top part of Table 8), it is meaningless to compare the Pcc and Pcc∗ values. Instead, we need to focus only on the same type of metric, namely by column, to compare the linear dependency of the feature with the class. Then, directing our attention to the information gain, we notice that many of the rules take into account attributes that are effectively able to perform the discrimination between the two classes. If we consider as useful the rules and features that have an information gain value higher than 0.5, we observe that, even if many rules exhibit a very low I gain, their “feature” version becomes much more interesting: for example, rules 18, 20, 21 and 22 have an evident increase in their information gain when used as features. Thus, we can derive that the rule is based on a right assumption (for example, the use of hashtags), but the rule definition is too simple to be effective: the algorithm proposed by [12] is simply too naive for the complex task of fake accounts detection in Twitter. Coincidentally, we have that the best performing rules also show the highest Pcc values, namely their satisfaction is more strongly related to the belonging class. Concerning the features underlying the rules, we find that the Pcc∗ is strongly reduced because, as above noticed, they can (and indeed do) assume very high values and this severely affects the linear correlation with the class. Observing the other rules of Table 8, we can notice how none of the criteria suggested by online blogs and by Socialbakers’ FakeFollowerCheck are successful in detecting the fake followers in our dataset. As an example, all rules by Van Den Beld have accuracy and precision close to 0.5 or a very low recall. Also, we observe that “tweet from API” has an MCC of -0.779, meaning that it is strictly related to the class of the account, but by an inverse factor: in our dataset, fake followers accounts almost never tweet from API (instead, they use Twitter.com to tweet), whereas human accounts have posted at least once from outside the website. This is exactly the opposite behavior than that suggested by the blogger for bots, that (are supposed to) almost exclusively post tweets using API. The relevance to the prediction task is also confirmed by both the I gain/I gain∗ and the Pcc/Pcc∗ values. Another interesting observation is that many rules proposed by Socialbakers have MCC values close to 0, meaning that their outcomes are almost unrelated with the class of the accounts. Indeed, the large majority of the accounts are recognized as humans, resulting in a high precision, accuracy around 0.5 and very low recall. The exception is rule 6, “0 tweets”: as a rule, it has an information gain value of 0.02, but when considered as a feature (i.e., number of tweets) it obtains 0.621. Similarly, rules 4 and 5 are much more useful for the detection process when considering their underlying features (namely, number of retweets and 17 number of tweets with URLs). Summarizing, independently from the typology of the account, the rules are almost always satisfied, leading to a severe flaw when dealing with fake followers detection. 5. Fake detection with algorithms based on feature sets In this section, we examine works in [8, 2] that address spam account detection on Twitter. Both of them propose a list of features to be extracted from manually classified datasets of accounts. Such feature sets are then used to train and test machine learning classifiers in order to distinguish between humans and spammers. Even if the proposed features have been originally designed for spam detection, here, for the first time, we consider them to spot another category of Twitter accounts, i.e., the fake followers. Although many other works exist in literature focused on Twitter spam detection (see Section 2), many of them consider features that can be in some way assimilated to those analyzed in this and in the previous section. Differently from the rule-based algorithms in Section 4, features are here presented as quantifications of properties of the considered samples. Therefore, they are introduced without any prior knowledge about the values for the features that will characterize the considered classes. Only after the training phase, it will be possible to observe which are the most frequent values for the features within the different classes. For our analysis, we employ classifiers that produce both “glass-box” and “black-box” models. In “glass- box” models, such as Decision Trees and Regression Models, the inner structure of the models can be understood by humans, also providing insights on how the classifiers identify fake accounts [39]. Instead, in “black-box” models, such as Support Vector Machines, the inner structure of the model does not have a direct human-explicable correspondence. 5.1. Detecting spammers in social networks The study presented in [8] focuses on spambot detection. The authors exploit several characteristics that can be gathered crawling an account’s details, both from its profile and timeline. For each investigated account, such characteristics are exploited in a Random Forest algorithm [23, 43], that outputs if the account is a spambot or not. The results of the analysis in [8] depicted some interesting features of the spambot accounts under investigation, as reported in Table 9. 1. spambots do not have thousands of friends; 2. spambots have sent less than 20 tweets; 3. the content of spambots’ tweets exhibits the so-called message similarity; 4. spambots have a high tweets containing URLs 5. spambots have a high ratio (URL ratio); total tweets friends (followers2) ratio value (i.e., lower ratio values mean legitimate users). Table 9: Feature set proposed by Stringhini et al. [8]. To evaluate feature 3, we implement the notion of message similarity by checking the existence of at least two tweets, in the last 15 tweets of the account timeline, in which 4 consecutive words are equal. This notion has been given in a later work by the same authors [25]. 18 Without the original training set, we were unable to reproduce the same classifier, but we picked the five features and used them to train a set of classifiers with our BAS dataset. The results are reported in Table 12 of Section 5.3. 5.2. Fighting evolving Twitter spammers The authors of [2] observed that Twitter spammers often modify their behavior in order to evade existing spam detection techniques. Thus, they suggested to consider some new features, making evasion more difficult for spammers. Beyond the features directly available from the account profile lookup, the authors propose some graph-, automation-, and timing-based features. In Table 10 we detail nine of them, together with the outcome of their analysis in [2]. friends 1. age of the account (this feature also appears in [28]): the more an account is aged, the more it could be considered a good one; 2. bidirectional link ratio ( bidirectional links ), where a bidirec- tional link occurs when two accounts follow each other: this feature has been tested to be lower for spammer accounts than for legitimate accounts; 3. average neighbors’ followers: the average number of followers of the account’s friends. This feature aims at reflecting the quality of the choice of friends of an account. The feature has been found to be commonly higher for legitimate accounts than for spammers; 4. average neighbors’ tweets: the average number of tweets of the account’s followers. This feature is lower for spammers than for legitimate accounts; followings to median neighbor’s followers: defined as the 5. ratio between the number of friends and the median of the fol- lowers of its friends. This feature has been found higher for spammers than for legitimate accounts; 6. API ratio ( tweets sent from API accounts; total number of tweets ): higher values for suspicious 7. API URL ratio ( tweets sent from API and containing URLs ratio is higher for suspicious accounts; total number of tweets sent from API ): such 8. API tweet similarity: this metric considers only the number of similar tweets sent from API. The notion of tweet similarity is as in Section 5.1. This metric is higher for suspicious accounts; following rate: this metric reflects the speed at which an 9. accounts follows other accounts. Spammers usually feature high values of this rate. Table 10: Feature set proposed by Yang et al. [2]. The authors of [2] combine their features in four different machine learning classifiers and compare their implementation with other existing approaches. We were unable to completely reproduce the machine learning classifiers in [2], since we had a different dataset. Instead, here we evaluate how those features, which proved to be quite robust against evasion techniques adopted by spammers, perform in detecting fake Twitter followers. As in [2], the following rate (feature 9) has been approximated with the ratio friends/age, since a precise evaluation would require to know the evolution of the number of friends of an account, but this is, indeed, publicly unavailable. Finally, in [2] there are also other features in addition to those mentioned above. However, as claimed by the same authors, they are less robust with regards to evasion techniques and thus we decided not to include them in our evaluation. 19 feature description I gain Pcc evaluation metrics number of friends number of tweets content of tweets Stringhini et al. [8] 1 2 3 4 URL ratio in tweets 5 friends (followers2) Yang et al. [2] 1 2 3 4 5 6 7 8 9 age bidirectional links ratio avg. followers of friends avg. tweets of friends firends / med. foll. of friends api ratio api url ratio api tweet similarity following rate 0.263 0.621 0.444 0.401 0.733 0.539 0.905 0.327 0.203 0.336 0.544 0.058 0.460 0.355 0.030 0.289 0.740 0.353 0.169 0.436 0.875 0.254 0.235 0.102 0.635 0.113 0.748 0.214 Table 11: Evaluation of the single feature. 5.3. Evaluation As done for the rule set in Section 4, we report in Table 11 the evaluation of the information gain and the Pearson correlation coefficient for all the features within the BAS dataset. Also in this case, since the Pcc evaluates the linear dependence between the considered feature and the class (that can only be 0 or 1), it produces results that are slightly different when compared to the information gain. Observing the results in Table 11, we can identify several promising features: “number of tweets” (already noticed in Section 4), “ratio between friends and followers2”, “bidirectional links ratio” and “API ratio”. The beneficial effect of the bi-link ratio will be further confirmed by the experiments of Section 5.4.3. To evaluate the combined effectiveness of the feature sets described in Sections 5.1 and 5.2 on detecting fake follower accounts, we employed 8 classifiers, obtained from different machine learning-based algorithms, namely: Decorate (D), Adaptive Boost (AB), Random Forest (RF), Decision Tree (J48), Bayesian Net- work (BN), k-Nearest Neighbors (kNN), Multinomial Ridge Logistic Regression (LR) and a Support Vector Machine (SVM). Our SVM classifier exploits a Radial Basis Function (RBF) kernel and has been trained using libSVM as the machine learning algorithm [44]. During the training phase of the SVM, the cost and gamma parameters have been optimized via a grid search algorithm. Similarly, the k parameter of the kNN classifier and the ridge penalizing parameter of the LR model have been optimized via a cross validation parameter selection algorithm. All the classifiers and the optimization algorithms employed in this work are implemented within the Weka framework [43]. Among these algorithms, RF was the only one used in [8]. Instead, authors of [2] employed D, RF, J48 and BN. We have decided to include AB in our work, since it is considered one of the most effective machine learning algorithms for classification tasks [39]. Furthermore, we also added other well-known and widely adopted classifiers, which are based on different classification techniques, such as SVM, kNN and LR, 20 algorithm accuracy precision recall F-M. MCC AUC evaluation metrics Classifiers based on feature set by Yang et al. [2] RF D J48 AB BN kNN LR SVM Support Vector Machine Random Forest Decorate Decision Tree Adaptive Boosting Bayesian Network k-Nearest Neighbors Logistic Regression 0.991 0.991 0.990 0.988 0.976 0.966 0.969 0.989 0.991 0.988 0.991 0.989 0.994 0.966 0.966 0.985 Classifiers based on feature set by Stringhini et al. [8] RF D J48 AB BN kNN LR SVM Support Vector Machine Random Forest Decorate Decision Tree Adaptive Boosting Bayesian Network k-Nearest Neighbors Logistic Regression 0.981 0.982 0.979 0.968 0.953 0.954 0.927 0.959 0.983 0.984 0.984 0.965 0.953 0.961 0.921 0.967 0.991 0.993 0.989 0.987 0.958 0.966 0.973 0.993 0.979 0.979 0.974 0.970 0.953 0.946 0.935 0.950 0.991 0.991 0.990 0.988 0.976 0.966 0.969 0.989 0.981 0.981 0.979 0.968 0.953 0.953 0.928 0.958 0.983 0.983 0.980 0.974 0.936 0.932 0.939 0.976 0.961 0.961 0.953 0.938 0.907 0.907 0.855 0.917 0.998 0.998 0.997 0.999 0.997 0.983 0.996 0.989 0.995 0.993 0.985 0.995 0.985 0.974 0.974 0.958 Table 12: Performance comparison for 10-fold cross validation. Training set: BAS . in order to perform a thorough evaluation of our detection system.We have built 8 classifiers adopting the features in Sections 5.1 and 5.2 and we have trained the models using our baseline (BAS ) dataset. Then, we have used a 10-fold cross validation [23] to estimate the performances of each obtained classifier. As for the rule-based algorithms in Section 4.4, we look at the MCC as the preferred metric to assess the classifiers’ performances. Table 12 summarises the results. The highest values for each metric are shown in bold. We can observe that all the classifiers have an excellent prediction capability. The ones built over the feature set of [2] achieve slightly better results. In particular, the RF, J48 and D classifiers have MCC greater than 0.98. Similarly, precision and recall are around 0.99 for all of them. In addition, all the classifiers based on the feature set by [2] have a higher AUC, when compared with the ones built with the feature set by [8]. Anyway, the latter also obtain high detection levels: accuracy, precision, and recall are around 0.98 for RF, D and J48, with a MCC of around 0.96. The lower precision and recall with respect to the ones obtained using the set of Yang et al. [2] show that the features of Stringhini et al. [8] exhibit the tendency to consider as fake followers some human accounts. With both the [2] and [8] feature sets, BN, kNN and LR classifiers achieve, overall, worse performances. The SVM classifier, instead, achieves remarkable results, especially with the feature set of [2]. Indeed, in this experiment SVM scores only slightly worse than RF, D and J48, and better than AB. Whereas, AB achieves extremely high performances when evaluated with the AUC metric. Finally, among all the considered classifiers and evaluation metrics, RF and D are the ones that have been proved to be more consistent. Overall, even if some small differences can be observed in the evaluation metrics, all the classifiers almost correctly distinguish between human and fake follower accounts, for our baseline BAS dataset. The feature- based classifiers are indisputably more accurate for fake follower detection when compared with the CC 21 algorithm, that does not perform well within our dataset, as observed in Section 4.5 above. 5.4. Discussion By examining the internal structure of the classifiers, we get insights about the best features that con- tribute more to distinguish between human and fake followers. In the case of decision trees, the best features are the ones closer to the root and the classifier automatically finds the numeric thresholds characterizing, for a given feature, the borderline between human and fake followers. It is worth noting that also the Dec- orate, AdaBoost, and Random Forest algorithms exploit, ultimately, combinations of simple decision tree classifiers. Despite their very good performance, they have the disadvantage of being difficult to analyze, since they can consist in tens of individual trees that interact together. Then, we only focus on the J48 classifier (a single decision tree) to examine how the features are applied during the classification process. 5.4.1. Differences between fake followers and spam accounts Looking at the tree structure, we observe some interesting differences between the fake followers in our BAS dataset and the spam accounts characterized in [8] and [2]. For example, the feature URL ratio has been found to have a higher value for spammers than for legitimate users, as highlighted in [8] (Section 5.1). Observing the tree structure of our J48 classifier, instead, low values for this feature characterize fake followers, compared with higher values that indicate human accounts in our baseline dataset. More than 72% of the fake followers in our training dataset have a URL ratio lower than 0.05, oppositely to 14% of human accounts. Similarly, the API ratio feature has been found higher for spammers than for legitimate accounts ([2], see also Section 5.2). In our dataset, the API ratio is lower than 0.0001 for 78% of fake followers. A similar behavior has been observed for the average neighbor’s tweets feature, that has been found to be lower for spammers in [2], but higher for our fake followers. These initial observations highlight a behavioral difference between a spam account and a fake follower. In particular, fake followers appear to be more passive compared to spammers and they do not make use of automated mechanisms for posting their tweets, as spammers usually do. 5.4.2. Reducing overfitting It is well known that trained classifiers can be subject to “overfitting”, namely the problem of being too specialized on the training dataset and unable to generalize the classification to new and unseen data [45]. A simple way to avoid overfitting is to keep the classifier as simple as possible. In case of a decision tree algorithm, for example, one solution could be reducing the number of nodes and, possibly, the height of the tree. The decision tree obtained with the feature set of Stringhini et al. [8] has 22 leaves, 43 nodes, and a height of 7, whereas the best feature is the friends/(followers2) ratio that places at the root. The decision tree with the feature set of Yang et al. [2] has 17 leaves, 33 nodes and a height of 8, with the bi-directional link ratio as the root. 22 pruning method nodes leaves height accuracy precision recall F-M. MCC AUC tree details evaluation metrics Decision tree based on feature set of Stringhini et al.[8] subtree raising 0.25 reduced error 3 folds reduced error 50 folds 22 16 5 43 31 9 7 5 4 Decision tree based on feature set of Yang et al.[2] subtree raising 0.25 reduced error 3 folds reduced error 50 folds 33 19 11 17 10 6 8 5 3 0.979 0.975 0.964 0.99 0.988 0.982 0.984 0.971 0.957 0.991 0.99 0.979 0.974 0.971 0.957 0.989 0.987 0.985 Decision tree based on feature set of Yang et al.[2], without the bi-link ratio feature 0.957 subtree raising 0.25 0.952 reduced error 3 folds reduced error 50 folds 0.934 0.96 0.961 0.933 0.963 0.969 0.931 101 53 37 10 8 9 51 27 19 0.979 0.971 0.957 0.99 0.988 0.982 0.96 0.96 0.933 0.953 0.943 0.914 0.98 0.976 0.966 0.917 0.914 0.866 0.985 0.989 0.984 0.997 0.993 0.993 0.971 0.978 0.967 Table 13: Performance comparison with increased pruning. 10-fold cross validation. Training set: BAS . A common practice to generalize the classifiers is the adoption of a more aggressive pruning strategy, e.g., by using the reduce-error pruning with small test sets [23, 43]. Adopting this strategy, we were able to obtain simpler trees with a lower number of nodes and a very reduced height. Such simpler trees generally use subsets of the feature set, still maintaining very good performance on our BAS dataset. Table 13 reports the characteristics and the performance of the experiments we have carried out, varying the pruning strategy. It is worth noting that the complexity of the tree is not always directly connected to an improvement in the detection capability: for example, for the feature set of Yang et al. [2], reducing the number of nodes from 33 to 11 decreases the accuracy of 0.007 and the MCC of 0.014, only. Similarly, the values for AUC remain almost the same between the pruned and the not pruned versions of the tree. Furthermore, we clearly observe that the pruned version of Stringhini et al. [8] reduces its recall of 0.017, while the one of Yang et al.[2] only drops of 0.004, meaning that the latter is able to miss fewer fakes than the former one after pruning. This is also evident from the higher reduction of both F-Measure and MCC. We think that this increased effectiveness is a direct consequence of the quality of the used features. Overall, the results of this experiment show that, even reducing the features, it is possible to have a detection rate higher than 0.95 (as in the last lines of Table 13, for [8] and [2], respectively). For instance, in those two experiments, the features used by the pruned tree were only bi-directional link ratio, the average neighbors’ followers, the age, and the followings to median neighbors’ followers as a subset of the original feature set of Yang et al. [2], and the friends/(followers2), URL ratio, and number of friends as the subset for the Stringhini et al. [8] original feature set. 5.4.3. Bidirectional link ratio In Section 5.3 we observed that the bidirectional link ratio had the highest information gain among all the considered features. In order to test if this is the decisive feature to distinguish between humans and fake followers and how much it influences the detection process, we compare the results of the previous 23 experiments with those of a new one. We build a decision tree classifier leaving out the bi-link ratio from the feature set of Yang et al. [2] and compare its effectiveness against the classifier built with the complete set. The results are reported in the last rows of Table 13. This experiment is particularly interesting since, as detailed in next Section 6, this feature is the most expensive to evaluate. The results in Table 13 show an evident decrease in accuracy, precision and recall for the less pruned trees (subtree raising 0.25 and reduced error 3 folds), as well as for both F-Measure and AUC, and an even noticeable decrease of the MCC measure. The reduced error pruning with 50 folds produces a classifier that has MCC dropping from 0.966 to 0.866. Its detection level (accuracy) is still very good for all the three pruned trees (0.964, 0.982 and 0.933, respectively), but we can clearly observe a remarkable drop in both precision and recall, compared to the version with the whole feature set. This suggests that the highest effectiveness we noticed in the above experiments after pruning (Section 5.4.2) is considerably lost when we do not consider the bi-link ratio feature. The most interesting aspect is the increased complexity of the decision tree: without the bi-link ratio, the classifiers need to resort to a considerably larger number of nodes. For example, the tree that does not use that feature, pruned with subtree raising confidence of 0.25, requires 101 nodes, whereas the tree that uses it requires only 33 nodes. From the results shown in Table 13, we conclude that the bidirectional link ratio is an important feature for fake follower detection: even if not essential, it is extremely effective for the detection process. By capturing the nature of the social ties between an account and its neighbors, this feature is intrinsically harder to beat than those based on simpler characteristics, like, e.g., other information in the account’s profile. 6. An efficient and lightweight classifier Feature set Class A (profile) Class B (timeline) Class C (relationships) Camisani-Calzolari [12] has name, has image, has address, has biography, followers ≥ 30, belongs to a list, tweets ≥ 50, URL in profile, 2 × followers ≥ friends geo-localized, is favorite, uses punctuation, uses hashtag, uses iPhone, uses Android, uses Foursquare, uses Instagram, uses Twitter.com, userID in tweet, tweets with URLs, retweet ≥ 1, uses different clients State of search [11] bot in biography, friends followers ≃ 100, duplicate profile pictures same sentence to many accounts, tweet from API Socialbakers [14] Stringhini et al. [8] friends followers ≥ 50, default image after 2 months, no bio, no location, friends ≥100, 0 tweets tweets spam phrases, same tweet ≥ 3, retweets ≥ 90%, tweet-links ≥ 90% number of friends, number of tweets, friends (followers2) tweet similarity, URL ratio Yang et al. [2] age, following rate API ratio, API URL ratio, API tweet similarity Table 14: Feature crawling cost classes. 24 bi-link ratio, average neighbors’ followers, average neighbors’ tweets, followings to median neighbor’s followers As previously shown in sections 4 and 5, the classifiers based on feature sets perform much better than those based on rules. Similarly, we have seen that the feature set proposed by Yang et al. [2] seems to be slightly more effective than the one proposed by Stringhini et al.[8], when used in feature-based classifiers aiming at fake followers detection. Here, we look for an efficient and lightweight classifier, exploiting the best features and the best rules, not only in terms of detection performance, but also considering their evaluation costs. In particular, we can distinguish between the computational cost and the crawling cost required to evaluate a feature (or a rule). Computational costs can be generally lowered with optimized algorithms and data representations and they are negligible when compared to the crawling costs. Thus, in this section we focus on the latter: we quantify the crawling cost of each feature and rule, and we build a set of lightweight classifiers that make use of the most efficient features and rules, in terms of crawling cost and fake followers detection capability. For the sake of readability, in the following section with the term “feature” we include all the features presented in sections 4 and 5, namely also the features underlying the analyzed rules. 6.1. Crawling cost analysis Intuitively, some features require few data for their calculation, while others require the download of big amounts of data. For the sake of this analysis, we divide the features in three categories: A) profile: features that require information present in the profile of the followers of the target account (like, e.g., profile has name); B ) timeline: features that require the tweets posted in the timeline of the followers of the target account (like, e.g., tweet from API ); C ) relationship: features that require information about the accounts that are in a relationship (i.e., that are a friend, or a follower, or both) with the followers of the target account (like, e.g., bidirectional link ratio). Each category, in turn, belongs to a crawling cost class directly related to the amount of data to be crawled from Twitter. Starting from the list of the followers of a target account, Class A features can be evaluated simply accessing to all the profiles of the followers; Class B features require to download all the tweets posted by each follower; Class C features need to crawl the friends and the followers of each follower of the target account. To evaluate the class of cost associated to each feature’s category, we estimate the number of Twitter API calls needed to download data required for the calculation. Results are in Tables 15 and 14. The following parameters refer to the Twitter account for which the number of fake followers is being investigated: f : number of followers of the target account; ti : number of tweets of the i-th follower of the target account; ϕi : number of friends of the i-th follower of the target account; 25 API calls Best-case Worst-case Calls/min. profile l f 100m Pi∈f l ti l f 100m 100m l f 12 16 ∗ f 12 f timeline relationships 200m Pi∈f (cid:16)l fi 5000m + (cid:6) ϕi 5000(cid:7)(cid:17) 2 ∗ f unpredictable 1 Table 15: Number of API calls needed to download data. fi : number of followers of the i-th follower of the target account. The number of API calls for each category depends on the maximum number of accounts (100), tweets (200) and friends/followers (5000) that can be fetched from Twitter with a single API request. For example, for the profile category, a single API call can return 100 follower profiles, leading to l f 100m API calls in total. The detailed costs do not account for the initial download of the whole list of f followers of the target account, that requires l f 5000m API calls. Table 15 also shows the minimum (Best-case) and maximum (Worst-case) number of API calls that could possibly be required, that depend on the length of the timelines and the number of relationships of the followers. The Best-case is when one single API call is sufficient to get all the data for a single follower. For the Worst-case we can only precisely evaluate the number of API calls for the timeline category, since the number of tweets that can be accessed from a user timeline is limited to 3200, leading to a maximum of 16 calls for each follower. The number of friends and followers, instead, is not limited and, therefore, it is impossible to calculate a worst-case scenario for the relationship category. However, just to provide an estimation, we can consider the account with the highest number of followers on Twitter, which, at the time of writing, belongs to the pop star Katy Perry (@katyperry), with about 60 millions of followers. We can therefore consider as the worst-case scenario an account with 60 millions followers and 60 millions friends, which leads to a number of API calls equal to 22000 ∗ f. Observing the values of Table 15, we have a clear idea of the order of magnitude of each class: features in Class B are 100 times more costly than features of Class A, while features of Class C could be several orders of magnitude more costly than features of Class A. Furthermore, to protect Twitter from abuse, the number of API calls allowed per minute is limited. In Table 15, we also report the maximum number of calls allowed per minute (Calls/min.), which directly impacts on the time needed to complete the data acquisition. Some further considerations follow. Firstly, data collected for a category can be used to evaluate all the features of that category. Secondly, Twitter limits the number of calls of the same API, but different APIs can be called in parallel. This means that data for all the three feature categories can be possibly acquired concurrently. The total time required to collect all data depends on the category that requires more time, i.e., the relationship one. In other words, to get the total time, one should not consider the sum of the time 26 algorithm accuracy precision recall F-M. MCC AUC evaluation metrics Class C classifiers that use all the features RF D J48 AB BN kNN LR SVM Support Vector Machine Random Forest Decorate Decision Tree Adaptive Boosting Bayesian Network k-Nearest Neighbors Logistic Regression 0.994 0.993 0.992 0.987 0.960 0.971 0.986 0.987 0.997 0.993 0.991 0.988 0.965 0.963 0.985 0.983 Class A classifiers that use only Class A (profile) features RF D J48 AB BN kNN LR SVM Support Vector Machine Random Forest Decorate Decision Tree Adaptive Boosting Bayesian Network k-Nearest Neighbors Logistic Regression 0.987 0.984 0.983 0.972 0.966 0.957 0.971 0.961 0.993 0.987 0.987 0.975 0.969 0.961 0.964 0.972 0.990 0.993 0.992 0.987 0.954 0.979 0.988 0.991 0.980 0.981 0.979 0.969 0.963 0.953 0.978 0.950 0.994 0.993 0.992 0.987 0.960 0.971 0.986 0.987 0.987 0.984 0.983 0.972 0.966 0.957 0.971 0.961 0.987 0.987 0.983 0.975 0.921 0.941 0.972 0.974 0.967 0.964 0.962 0.941 0.928 0.914 0.942 0.923 0.999 0.999 0.993 0.999 0.991 0.990 0.996 0.987 0.995 0.995 0.983 0.995 0.991 0.978 0.987 0.961 Table 16: Performance comparison for 10-fold cross validation. Training set: BAS . needed for each of the three cost classes, but just the most costly one. 6.2. The Class A classifier All the rules and features considered in this study fall into one of the three aforementioned categories, as reported in Table 14. Therefore, their crawling cost impacts on the final cost of the whole feature set and, ultimately, to the class of the classifier: a classifier that uses a certain feature set belongs to the class of the more expensive feature. Then, all the classifiers of the previous sections are classifiers of Class B, with the exception of the classifier with the feature set of Yang et al. [2], that belongs to Class C. In the following, we consider a lightweight classifier working only with features of Class A. We aim at verifying whether the Class A classifier reaches performances that are comparable to those of the most expensive Class B and Class C classifiers. Table 16 reports the results of the classifiers built on our BAS dataset, using two different feature sets: all the features (independently from their cost) and the Class A features. We start observing that the Class C classifiers, built over all the features considered in our study, perform better than all the other ones, including the classifiers using the feature sets of Yang et al. [2] and Stringhini et al. [8], as reported in Table 12. In particular, RF, D and AB achieve an AUC as high as 0.999. Class C classifier only slightly outperforms Class A classifier. Indeed, there is a difference of around 0.02 in MCC for RF, D and J48. The AUC reduction is even smaller, only 0.004 for RF, D, J48 and 0 for BN. It is worth noting that the Class A classifier with BN outperforms the Class C competitor, noticeably obtaining an increase in all the metrics, but the AUC. Instead, the Class A kNN, LR and SVM classifiers suffer from a significant drop in performances with respect to the Class C counterparts. 27 Concerning the complexity of the two decision trees obtained with the J48 algorithm, they are compa- rable, since both of them are composed by 31 nodes and 16 leaves and they have a height of 7. A further interesting observation is that both the classifiers employ a set of features that includes both features pro- posed by the grey literature for fake detection, which we introduced in Section 4, and by Academia for spam and bot detection, as detailed in Section 5. The analysis carried out in Section 6.1 highlights the effort and time needed to compute many of the features commonly proposed for the detection of spam and fake accounts. As shown by the Katy Perry example, crawling costs for some of the proposed features are totally infeasible for accounts with hundreds of thousands or millions of followers. For this reason, we trained and evaluated the proposed Class A classifiers, which achieve overall good performances, while only exploiting cost-efficient features. The Class A classifiers thus represent a feasible solution for the investigation of fake followers on a large scale. We have to point out, however, that countermeasures could be taken to evade some of the simplest features our classifiers are built upon [2]. This would require to continually monitor and update the choice of such features, to keep pace with the fake follower generators. While contemporary fake Twitter followers are effectively and efficiently spotted by our Class A classifier, we can consider the use of the most expensive Class B or even Class C features to have stronger evidences about the more suspicious followers. 6.3. Validation of the Class A classifier In this section, we propose a validation of our Class A classifier, built with our baseline BAS dataset. In particular, we set up two different experiments based on a random sampling of Twitter accounts. For the first experiment, we built a set of 1000 Twitter accounts, randomly selecting numeric Twitter user IDs, ranging from user ID 12 (the very first valid Twitter account – @jack – belonging to Jack Dorsey, founder of Twitter) to the user ID representing the last Twitter account created at the time of our experiment. This represents an unbiased sample of all the currently available (i.e., not closed, banned or suspended) Twitter accounts. This test set therefore comprises a broad range of accounts created during the nine years since Twitter’s advent. For the second experiment, instead, we consider a random sample of 1500 accounts among the followers of the US President Barack Obama – @BarackObama. This experiment resembles the practical application scenario of the proposed classifier, since it investigates a sample of a single account’s followers, in this case a major politician. All the accounts acquired with the two aforementioned approaches have been labeled as humans, following the same approach used in [26]. Twitter officially reports that fake and spam profiles together are less than 5% of all registered accounts [35], therefore we are confident that just a few among the accounts labeled as humans might actually be fake ones. Automatically labeling the sampled accounts as humans would result in an error of at most 5%, still allowing an overall correct validation of our classifiers. In addition, many of the accounts randomly acquired for the first and second experiment show few signs of activity on Twitter 28 algorithm accuracy precision recall F-M. MCC AUC evaluation metrics Class A validation on a test set of random sampled accounts RF D J48 AB BN kNN LR SVM Support Vector Machine Random Forest Decorate Decision Tree Adaptive Boosting Bayesian Network k-Nearest Neighbors Logistic Regression 0.975 0.904 0.904 0.767 0.891 0.946 0.551 0.955 0.982 0.894 0.898 0.737 0.876 0.962 0.922 0.982 0.975 0.948 0.942 0.936 0.947 0.944 0.252 0.941 0.979 0.920 0.920 0.825 0.910 0.953 0.396 0.961 Class A validation on a test set of random sampled Obama followers RF D J48 AB BN kNN LR SVM Support Vector Machine Random Forest Decorate Decision Tree Adaptive Boosting Bayesian Network k-Nearest Neighbors Logistic Regression 0.975 0.948 0.942 0.936 0.947 0.655 0.290 0.897 0.929 0.909 0.902 0.862 0.786 0.733 0.615 0.873 0.889 0.875 0.868 0.810 0.710 0.763 0.784 0.851 0.930 0.910 0.903 0.868 0.811 0.705 0.423 0.873 0.949 0.802 0.801 0.526 0.776 0.889 0.299 0.910 0.862 0.820 0.807 0.733 0.607 0.469 0.278 0.748 0.989 0.975 0.962 0.959 0.961 0.969 0.827 0.958 0.970 0.964 0.924 0.949 0.943 0.828 0.794 0.874 Table 17: Class A classifier validation on two different test sets. (more than 70% of them did not post a tweet in the 3 months prior to our data acquisition). Thus, more reliable checks like CAPTCHA-based verifications would result in very sparse answers. Furthermore, we believe that also including less active accounts in our test sets, allows to validate our classifiers with Twitter accounts having different characteristics than those of our baseline dataset of humans in Section 3.3 (e.g., showing fewer “human” features). Together with the human accounts, the test set also includes the 1401 fake followers we bought, but not included in the BAS dataset that we used as training set (Section 3.5). In Table 17, we report the results of the experiments on the test sets. Comparing results of Table 17 with those of Tables 12 and 16, we notice a broader range of performances. Indeed, while in Tables 12 and 16 almost all the considered classifiers achieved comparable performances, here we can see some major differences. This means that the increased difficulty of the detection task on the two considered test sets highlighted differences that were not visible in the previous experiments. From Table 17, we can observe that the validation against sampled Obama followers (bottom half of the table) proves to be more error prone than that against random sampled accounts. Indeed, almost all the classifiers achieve worse results in the former experiment, as deducible, for instance, from the AUC scores. Observing the validation against the random sampled accounts, we can see that the five Class A classifiers obtain an accuracy above 0.9, a precision close to (when not much higher than) 0.9 and a recall above 0.94: this means that they are able to spot almost all the fake followers of the test set. This is particularly true for the best performing classifier, RF, that reaches 0.975 for both accuracy and recall, with a precision of 0.982. The highest performances are also shown by both F-measure and MCC values, that are noticeably higher for RF when compared with the others. AB and BN obtain lower results for both accuracy and precision, but still a noticeably high recall, meaning that only few fake followers are left behind, but a 29 considerably higher number of human accounts are classified as fake followers. Among all the classifiers, LR is the one achieving the worst performances, because of the low MCC values obtained with both the test sets: 0.299 and 0.278 respectively. For the validation against sampled Obama followers, also kNN achieves unsatisfactory performances, with MCC equal to 0.469. The SVM classifier, instead, proves to be extremely effective, being the second best classifier when validated against random sampled accounts, and still performing very well against sampled Obama followers. The RF, D, and J48 classifiers obtain results that are comparable for the two test sets, with an accuracy greater than 0.9 and a precision close to 0.87, with a reduction of only 0.025 on average. This is also confirmed by both the F-measure and MCC that are very close to the results above. In the two validation experiments, AB and BN noticeably switch their performances: the Adaptive Boosting algorithm raises its accuracy of 0.1 and its precision of around 0.08, outperforming the Bayesian Network-based one. This latter looses 0.105 of accuracy, meaning that many of the accounts we labeled as humans were recognized as fake followers. Also the RF classifier looses 0.4 of accuracy and a considerable 0.1 in precision, meaning that it considers as fake followers many of the sampled Obama’s followers. We can finally observe that the AUC metric is always very high and that does not consistently reflect the real performances obtained by the five classifiers, as the F-measure and the MCC actually do. 6.4. Assessing the global importance of Class A features Motivated by the results obtained by our Class A classifiers, we went further to asses the global impor- tance of Class A features towards the detection of fake Twitter followers. In order to estimate the importance of the single features among all the 8 classifiers, we followed the information fusion-based sensitivity analysis technique adopted in [46]. Information fusion is a technique aimed at leveraging the predictive power of several different models in order to achieve a combined prediction accuracy which is better than the predic- tions of the single models [47]. Sensitivity analysis, instead, aims at assessing the relative importance of the different features used to build a classification model [48]. It is therefore possible to combine information fusion and sensitivity analysis to estimate the global importance of several features, used in different machine learning classifiers, towards a common classification task. To reach this goal, we firstly re-train each of the 8 Class A classifiers with our baseline BAS dataset, by removing one feature at a time. This leads to 19×8 different classifiers. Subsequently, each of those classifiers is evaluated against our test sets. The local sensitivity score for the i-th feature of the j-th classifier can be computed as Sj,i = M CCj,−i M CCj , namely as the reduction in classification performance of j when used without the feature i with respect to the classification performance of j using all the 19 Class A features. Then, we can compute a global sensitivity score for the i-th feature via a weighted sum of the local sensitivities, Si = Pj Table 17, so that the best performing classifiers are weighted more. Finally, we rank features and assess wjSj,i. The weighting factor wj is proportional to the MCC of the j-th classifier, as reported in 30 rank feature proposed in normalized score 1 2 3 4 5 6 7 8 9 10 11 12 13 14 15 16 17 18 19 friends/(followers2) ratio age number of tweets profile has name number of friends has URL in profile following rate default image after 2 months belongs to a list profile has image friends/followers ≥ 50 bot in biography duplicate profile pictures 2 × followers ≥ friends friends/followers ≃ 100 has address no bio, no location, friends ≥ 100 has biography number of followers [8] [2, 28, 4, 1] [1, 4, 8, 12, 14] [12] [32, 8, 14, 4] [12] [2] [14] [12] [12] [14] [11] [11] [11] [11] [12] [14] [12] [12, 4, 3] 1.000 0.919 0.816 0.782 0.781 0.768 0.765 0.755 0.752 0.751 0.736 0.734 0.731 0.721 0.707 0.677 0.664 0.602 0.594 Table 18: Global importance of Class A features for the detection of fake Twitter followers. their relative importance by normalizing their global sensitivities, so that the best performing feature has a normalized score of 1. Table 18 shows the results of this information fusion-based sensitivity analysis. Notably, none of the features is clearly dominant: all the 19 Class A features give a significant contribution to the detection of fake Twitter followers. Results of this in-depth analysis also show a considerable agreement with our feature evaluation studies reported in Tables 8 and 11. Specifically, the most important feature of Table 18, namely f riends/(f ollowers2) ratio, is the second best feature in Table 11, outperformed only by the Class C feature bidirectional link ratio. Given the relevant contribution of other features such as number of friends and following rate, we believe that features aimed at evaluating the social ties between an account and its neighbors play a central role towards the detection of fake Twitter followers. 7. Conclusions In this paper, we focused on efficient techniques for fake Twitter followers detection. To reach the goal, we firstly created a baseline dataset of human and fake follower accounts, the latter being bought from available online markets. Then, we surveyed various proposals for spammer and bot detection, based on classification rules and feature sets. Such proposals come partly from Academia and partly from the grey literature. Such rules and features were eventually tested on our dataset to understand their effectiveness in detecting fake Twitter followers. A few features were selected and used by a set of classifiers that we have trained on the baseline dataset. Going further, we ranked the best performing features according to their crawling cost. This led us to identify three categories of features belonging to three different, increasing, cost classes. Finally, we built a series of classifiers that only leverage cost-effective 31 (Class A) features. With this final outcome, we were able to achieve detection rates comparable with the best of breed classifiers, whereas these latter necessitate overhead-demanding features. Among the results of this study, there is the construction of a baseline dataset of verified human and fake follower accounts. To foster research on the novel issue of fake Twitter followers, we have publicly released our dataset to the scientific community [33]. For our analysis, we considered 49 distinct features and 8 different “glass-box” and “black-box” machine learning classifiers. So-called “glass-box” classifiers produce interpretable models and an analysis of their inner structure allows to get insights into the mechanisms exploited to perform the detection. In turn, this is useful to better understand the characteristics of Twitter accounts that can be leveraged to discriminate between fake and genuine followers. Nonetheless, “black-box” classifiers have been recently employed in a broad range of diverse classification tasks, achieving excellent results. Therefore, for the sake of experimen- tation, we expanded the set of machine learning algorithms employed in previous works on fake and spam detection, with the adoption of powerful classifiers, such as Support Vector Machines (SVM). Indeed, the results of our analyses confirm that SVMs achieve results comparable to those of the best performing classi- fiers (such as Random Forest and Decorate). The adoption of other powerful classification techniques, such as Artificial Neural Networks (ANNs), could provide other interesting results and, therefore, we consider its adoption and evaluation promising ground for future work. Among all the analyzed features, we have seen that those yielding the best results are the ones based on the friends and followers of the account under investigation, such as the bidirectional link ratio and the f riends/(f ollowers2) ratio. By evaluating the social ties between an account and its neighbors, these features are more effective than those based on simpler characteristics, like, e.g., other information in the account’s profile. However, relationships-based (Class C ) features are more demanding in terms of data to be downloaded and, consequently, they require a significant analysis time, making them unsuitable for analyses on massive amounts of followers. Timeline-based (Class B ) features have been shown to be less time-demanding, while still effective; hence, these might represent a promising trade-off between efficient and accurate detections. Anyway, as shown by the proposed Class A classifiers, the detection of currently available fake Twitter followers is possible even without leveraging resource-demanding features, by means of efficient algorithms and accurate selection and combination of less-demanding features. We also evaluated the global importance of the Class A features for the fake Twitter follower detection, using information fusion-based sensitivity analysis and showing that those based on social relations play a dominant role. As future work, we aim at designing and testing other advanced features that could be added to our lightweight fake followers’ classifier, leveraging additional characteristics of Twitter accounts. Data that could be further exploited for the classification task are the content of tweets and the accounts’ behav- ior. In particular, bot development forums represent a fruitful source of information to know more about bot/fake/spam accounts design, in terms, e.g., of similarities and differences in their behavior. As high- 32 lighted by our work, the difficulty of the detection task and the massive numbers of accounts to analyze ask for the adoption of features that are not only effective, but also efficient, with regard to their crawling costs. Therefore, we believe that future works along this line of research should consider the balance between the predictive power of new features and their cost. This would allow to improve the detection of fake Twitter followers, while still retaining a scalable approach, making en masse analysis practically feasible. It is foreseeable that countermeasures will be taken to masquerade a fake account with respect to some of the simplest features which our classifiers are built upon. This would require to continually monitor and update the choice of such features, conceivably studying (or directly interacting with) the same generators of fakes, to keep their pace. Therefore, we believe that the features renovation process can be considered as another interesting direction for future research. Acknowledgements The authors would like to thank the anonymous reviewers who helped improving the quality of the manuscript. References References [1] Z. Chu, I. Widjaja, H. Wang, Detecting social spam campaigns on Twitter, in: Applied Cryptography and Network Security, Springer, 2012, pp. 455–472. [2] C. Yang, R. Harkreader, G. Gu, Empirical evaluation and new design for fighting evolving Twitter spammers, Information Forensics and Security, IEEE Transactions on 8 (8) (2013) 1280–1293. [3] F. Ahmed, M. Abulaish, A generic statistical approach for spam detection in online social networks, Computer Commu- nications 36 (10) (2013) 1120–1129. [4] Z. Miller, B. Dickinson, W. Deitrick, W. Hu, A. H. Wang, Twitter spammer detection using data stream clustering, Information Sciences 260 (2014) 64–73. [5] M. Cha, H. Haddadi, F. Benevenuto, P. K. Gummadi, Measuring user influence in Twitter: The million follower fallacy, ICWSM 10 (10-17) (2010) 30. [6] C. Castillo, M. Mendoza, B. Poblete, Information credibility on Twitter, in: Proceedings of the 20th international confer- ence on World Wide Web, ACM, 2011, pp. 675–684. [7] J. S. Alowibdi, U. A. Buy, P. S. Yu, L. Stenneth, Detecting deception in online social networks, in: Advances in Social Networks Analysis and Mining (ASONAM), 2014 IEEE/ACM International Conference on, 2014, pp. 383–390. [8] G. Stringhini, C. Kruegel, G. Vigna, Detecting spammers on social networks, in: 26th Annual Computer Security Appli- cations Conference, ACSAC ’10, ACM, 2010, pp. 1–9. [9] Y. Boshmaf, I. Muslukhov, K. Beznosov, M. Ripeanu, The socialbot network: When bots socialize for fame and money, in: 27th Annual Computer Security Applications Conference, ACSAC ’11, ACM, New York, NY, USA, 2011, pp. 93–102. [10] Z. Chu, S. Gianvecchio, H. Wang, S. Jajodia, Detecting automation of Twitter accounts: Are you a human, bot, or cyborg?, IEEE Trans. Dependable Sec. Comput. 9 (6) (2012) 811–824. [11] Stateofsearch.com, How to recognize Twitterbots: 7 signals to look out for., http://goo.gl/YZbVf, Last checked 23/07/15 (August 2012). [12] Camisani-Calzolari M. (digitalevaluations), Analysis of Twitter followers of the US Presidential Election candidates: Barack Obama and Mitt Romney (August 2012). [13] Statuspeople.com, Status People Fakers, http://goo.gl/0Jpky, Last checked 23/07/15. [14] SocialBakers, Fake follower check, http://goo.gl/chWn0, Last checked 23/07/15. [15] Twitteraudit, How many of your followers are real?, www.twitteraudit.com, Last checked 23/07/15. [16] S. Cresci, R. Di Pietro, M. Petrocchi, A. Spognardi, M. Tesconi, A Criticism to Society (as seen by Twitter analytics), in: 1st International Workshop on Big Data Analytics for Security, IEEE, 2014, pp. 194–200. [17] H. Gao, Y. Chen, K. Lee, D. Palsetia, A. N. Choudhary, Towards online spam filtering in social networks, in: 19th Annual Network and Distributed System Security Symposium, NDSS 2012, San Diego, California, USA, February 5-8, 2012, 2012. [18] S. Lee, J. Kim, WarningBird: A near real-time detection system for suspicious URLs in Twitter stream, IEEE Trans. Dependable Secur. Comput. 10 (3) (2013) 183–195. [19] K. Thomas, C. Grier, J. Ma, V. Paxson, D. Song, Design and evaluation of a real-time URL spam filtering service, in: 32nd IEEE Symposium on Security and Privacy, S&P 2011, 22-25 May 2011, Berkeley, California, USA, 2011, pp. 447–462. 33 [20] A. Zubiaga, H. Ji, Tweet, but verify: epistemic study of information verification on Twitter, Social Network Analysis and Mining 4 (1) (2014) 1–12. [21] H. Gao, Y. Yang, K. Bu, Y. Chen, D. Downey, K. Lee, A. Choudhary, Spam ain’t as diverse as it seems: Throttling OSN spam with templates underneath, in: Annual Computer Security Applications Conference, ACSAC, 2014, pp. 76–85. [22] Y. Liu, B. Wu, B. Wang, G. Li, SDHM: A hybrid model for spammer detection in Weibo, in: Advances in Social Networks Analysis and Mining (ASONAM), 2014 IEEE/ACM International Conference on, 2014, pp. 942–947. [23] M. Hall, I. Witten, E. Frank, Data Mining: Practical Machine Learning Tools and Techniques, 3rd Edition, Morgan Kaufmann, 2011. [24] S. Lee, J. Kim, Early filtering of ephemeral malicious accounts on Twitter, Computer Communications 54 (2014) 48–57. [25] G. Stringhini, M. Egele, C. Kruegel, G. Vigna, Poultry markets: on the underground economy of Twitter followers, in: Workshop on online social networks, WOSN ’12, ACM, 2012, pp. 1–6. [26] G. Stringhini, G. Wang, M. Egele, C. Kruegel, G. Vigna, H. Zheng, B. Y. Zhao, Follow the Green: Growth and Dynamics in Twitter Follower Markets, in: Internet Measurement Conference, IMC ’13, 2013, pp. 163–176. [27] K. Thomas, D. McCoy, C. Grier, A. Kolcz, V. Paxson, Trafficking fraudulent accounts: The role of the underground market in Twitter spam and abuse, in: 22nd USENIX Security Symposium, USENIX, Washington, D.C., 2013, pp. 195–210. [28] K. Lee, J. Caverlee, S. Webb, Uncovering social spammers: social honeypots + machine learning, in: SIGIR Conference on Research and Development in Information Retrieval, ACM, 2010, pp. 435–442. [29] S. Yardi, D. M. Romero, G. Schoenebeck, D. Boyd, Detecting Spam in a Twitter Network, First Monday 15 (1). [30] G. Yan, Peri-Watchdog: Hunting for hidden botnets in the periphery of online social networks, Computer Networks 57 (2) (2013) 540–555. [31] M. McCord, M. Chuah, Spam detection on Twitter using traditional classifiers, in: Autonomic and Trusted Computing, Vol. 6906 of LNCS, Springer Berlin Heidelberg, 2011, pp. 175–186. [32] S. Y. Bhat, M. Abulaish, Using communities against deception in online social networks, Computer Fraud & Security 2014 (2) (2014) 8–16. [33] The Fake Project, Dataset, http://mib.projects.iit.cnr.it/dataset.html. [34] G. M. Weiss, F. Provost, Learning when training data are costly: the effect of class distribution on tree induction, Journal of Artificial Intelligence Research 19 (2003) 315–354. [35] Twitter Inc., Twitter’s IPO filing, http://www.sec.gov/Archives/edgar/data/1418091/000119312513390321/d564001ds1.htm, Last checked 23/07/15 (Oct 2013). [36] R. Kohavi, F. Provost, Glossary of terms, Machine Learning 30 (2-3) (1998) 271–274. [37] P. Baldi, S. Brunak, Y. Chauvin, C. Andersen, H. Nielsen, Assessing the accuracy of prediction algorithms for classification: an overview, Bioinformatics 16 (5) (2000) 412–424. [38] D. M. W. Powers, Evaluation: from precision, recall and F-measure to ROC, informedness, markedness and correlation, International Journal of Machine Learning Technologies 2 (1) (2011) 37–63. [39] J. Friedman, T. Hastie, R. Tibshirani, The elements of statistical learning, Vol. 1, Springer Series in Statistics, 2001. [40] T. M. Mitchell, Machine Learning, 1st Edition, McGraw-Hill, Inc., New York, NY, USA, 1997. [41] J. Rice, Mathematical statistics and data analysis, Cengage Learning, 2006. [42] I. Guyon, A. Elisseeff, An introduction to variable and feature selection, The Journal of Machine Learning Research 3 (2003) 1157–1182. [43] M. Hall, E. Frank, G. Holmes, B. Pfahringer, P. Reutemann, I. H. Witten, The WEKA data mining software: an update, ACM SIGKDD explorations newsletter 11 (1) (2009) 10–18. [44] C.-C. Chang, C.-J. Lin, LIBSVM: A library for Support Vector Machines, ACM Transactions on Intelligent Systems and Technology (TIST) 2 (3) (2011) 27. [45] D. M. Hawkins, The problem of overfitting, Journal of chemical information and computer sciences 44 (1) (2004) 1–12. [46] C. Sevim, A. Oztekin, O. Bali, S. Gumus, E. Guresen, Developing an early warning system to predict currency crises, European Journal of Operational Research 237 (3) (2014) 1095–1104. [47] C. W. Chase Jr, Composite forecasting: combining forecasts for improved accuracy, Journal of Business Forecasting Methods & Systems 19 (2) (2000) 2. [48] A. Saltelli, Making best use of model evaluations to compute sensitivity indices, Computer Physics Communications 145 (2) (2002) 280–297. 34
1206.5259
1
1206
2012-06-20T15:00:16
A Tractable Approach to Finding Closest Truncated-commute-time Neighbors in Large Graphs
[ "cs.SI", "cs.DS", "physics.soc-ph" ]
Recently there has been much interest in graph-based learning, with applications in collaborative filtering for recommender networks, link prediction for social networks and fraud detection. These networks can consist of millions of entities, and so it is very important to develop highly efficient techniques. We are especially interested in accelerating random walk approaches to compute some very interesting proximity measures of these kinds of graphs. These measures have been shown to do well empirically (Liben-Nowell & Kleinberg, 2003; Brand, 2005). We introduce a truncated variation on a well-known measure, namely commute times arising from random walks on graphs. We present a very novel algorithm to compute all interesting pairs of approximate nearest neighbors in truncated commute times, without computing it between all pairs. We show results on both simulated and real graphs of size up to 100; 000 entities, which indicate near-linear scaling in computation time.
cs.SI
cs
SARKAR & MOORE 335 ATractableApproachtoFindingClosestTruncated-commute-timeNeighborsinLargeGraphsPurnamritaSarkarMachineLearningDepartmentCarnegieMellonUniversityPittsburgh,PA15213AndrewW.MooreGoogleInc.Pittsburgh,PA15213AbstractRecentlytherehasbeenmuchinterestingraph-basedlearning,withapplicationsincollaborativefilteringforrecommendernet-works,linkpredictionforsocialnetworksandfrauddetection.Thesenetworkscanconsistofmillionsofentities,andsoitisveryim-portanttodevelophighlyefficienttechniques.Weareespeciallyinterestedinacceleratingrandomwalkapproachestocomputesomeveryinterestingproximitymeasuresofthesekindsofgraphs.Thesemeasureshavebeenshowntodowellempirically(Liben-Nowell&Kleinberg,2003;Brand,2005).Weintro-duceatruncatedvariationonawell-knownmeasure,namelycommutetimesarisingfromrandomwalksongraphs.Wepresentaverynovelalgorithmtocomputeallinterestingpairsofapproximatenearestneighborsintruncatedcommutetimes,withoutcomput-ingitbetweenallpairs.Weshowresultsonbothsimulatedandrealgraphsofsizeupto100,000entities,whichindicatenear-linearscalingincomputationtime.1IntroductionThemainaimoflink-predictionandcollaborative-filteringistoanswerthequestion,foranyselectednode:whichothernodesinthegrapharenearesttothisnode?Itisimportanttohaveausefulproximitymeasureforthispurposeandverydesirablefornearnodestobecomputedquickly.Ideallywewillwantthissimilaritymetrictocapturethegraphstructure.Forexampleiftwonodeshavemanycommonneigh-bors,theyarehighlysimilar.Ontheotherhand,imag-ineagraphwithtwodistinctconnectedcomponents,connectedbyasinglelink.Thetwonodesconnectingthecomponentsareneighborsinthegraphbutbelongtodifferentclusters,andareexpectedtobelesssimilarthantheirneighborsinthesamecomponent.Aratherintuitivewayofcapturingthisistheexpectedpathlengthfromonenodetoanotherduringarandomwalk.Thismeasureiscalledthehittingtime(Aldous&Fill,2001),andittellsushowlongitwilltakeonanaveragetohitthedestinationnodefromasourcenode.Notehoweverthatthismeasureisnotguaran-teedtobesymmetric.Henceit’seasiertoworkwiththeroundtriptime,i.e.thecommutetimebetweentwonodes.Thesemeasuresareinherentlyrobusttonoiseandexploittheinformationencodedinthegraphstructure.Theyarewidelyusedforunsupervisedandsemi-supervisedlearning(Zhuetal.,2003).Inspiteofbeingverysuccessfulforcollaborativefilter-ing(Brand,2005),dimensionalityreduction(Saerensetal.,2004)orimagesegmentationproblems(Qiu&Hancock,2005),themaindrawbackofthesemea-suresisthecomputationalload.Inpreviousworkau-thorshaveusedapproximatesparsematrixinversiontechniques(Brand,2005)orsubspaceapproximationsusingprincipaleigenvectors(Saerensetal.,2004)toavoidO(n3)computation.Howeverthesetechniquesdonotscaletographswithmorethanfewthousandsofnodes.Brand(2005)usescleveriterativeapproachestoavoidthisbottleneck,butsomequantitiesderivedfromtherandomwalkarelooselyapproximated.Inthispaperweintroduceatruncatedvariantofran-domwalksinordertoexploitlocalstructureingraphs,anddeviseanovelalgorithmtocomputeallinterestingpairsofnear-neighborsunderthistruncatedversionofcommutetimeswithouthavingtocomputetheentirecommutetimesmatrix.Resultsonbothsimulatedandrealnetworksofsizeup-to100,000(onasingleproces-sor)indicatenear-linearscalingincomputationtime.2RandomwalksonundirectedgraphsInthissectionweintroducesomebasicconceptsofrandomwalksonundirectedgraphs.AnundirectedgraphGhasasetofverticesVnumbered1ton,andasetofedgesE.Anedgeisapair(i,j)wherei,j∈V, 336 SARKAR & MOORE and(i,j)∈E⇔(j,i)∈E.TheadjacencymatrixWofGisann×nmatrixofrealvalues,whereWijdenotestheweightonedgei,j,andiszeroiftheedgedoesnotexist.ForundirectedgraphsWissymmetric.Disann×ndiagonalmatrix,whereDii=(cid:80)jWij.WewilldenoteDiibythedegreed(i)ofnodeifromnowon.TheLaplacianLofGisdefinedasD−W.Considerarandomwalk(Lovasz,1996)onGsuchthat,ifatsteptweareinvertexvt=i,theninthenextstepwemovetoaneighborofiwithprob-abilityproportionaltotheweightwijofthelink,i.e.wijDii.Clearlythesequenceofnodesv0,v1,...,vtformamarkovchain.WehavePt(i)=Pr(vt=i).P=pij,i,j∈Vdenotesthetransitionprobabilitymatrixofthismarkovchain,sothatpij=wij/Diiif(i,j)∈Eandzerootherwise.Inarandomwalk,ifnodev0ischosenfromadistribu-tionP0,thenthedistributionsP0,P1,..areingeneraldifferentfromoneanother.HoweverifP0=P1,thenwesaythatP0isthestationarydistributionforthegraph.ItcanbeshownthatforagraphGthesta-tionarydistributionisgivenbyπ(v)=d(v)V(G),whereV(G)=(cid:80)vd(v),denotesthevolumeofthegraph.Wenowintroducetwomainproximitymeasuresde-rivedfromrandomwalks,namelythehittingandthecommutetime(Aldous&Fill,2001).HittingtimeH:Thehittingtimebetweennodesiandjisdefinedastheexpectednumberofstepsinarandomwalkstartingfromibeforenodejisvisitedforthefirsttime.H=hij,i,j∈Visann×nmatrix.Recursivelyhijcanbewrittenashij=1+(cid:80)kpikhkjifi(cid:54)=jandzerootherwise.Hittingtimesareunsymmetric,howevertheyfollowthetriangleinequality(Lovasz,1996).CommutetimeC:Commutetimebetweenapairofnodesisdefinedascij=hij+hjiandissymmetric.cijcanalsobedefinedascij=V(G)(l+ii+l+jj−2l+ij)=V(G)(ei−ej)TL+(ei−ej)(1)SinceeachrowofthegraphLaplaciansumstozero,ithasaneigenvectorofallones,witheigen-valuezero.Itiscommonpractice(Saerensetal.,2004)toshiftthezero-eigenvaluebysubtractingtheallonesmatrix,invertingtheresultingmatrix,andthenaddingtheallonesmatrixbackagain,i.e.L+=(L−1n11T)−1+1n11T.Thepseudo-inverseofL,i.e.L+,canbeviewedasakernel(Smola&Kondor,2003)whichmapseachver-texofagraphtoaEuclidianspacei(cid:55)→xi.PairwisecommutetimecanbeexpressedasthesquaredEuclid-iandistanceinthetransformedspace(equation(1)),wherexi=(L+)12ei.LetusnowlookattheentriesofL+intermsofthesepositionvectors.Theij-thentryl+ij=xTixj,denotesthedot-productbetweenthepo-sitionvectorsofvertexiandj.Thediagonalelementl+iidenotesthesquaredlengthofthepositionvectorofi.Thecosinesimilarity(Brand,2005)betweentwonodesisdefinedasl+ij/(cid:113)l+iil+jj.WediscussdifferentwaysofcomputingtheabovequantitiesinSection3.Robustnesstowardsnoise:Hittingandcommutetimesarerobusttonoise.DoyleandSnell(1984)viewanundirectedunweightedgraphasanelectricalnet-workwitheveryedgereplacedbyanunitweightresis-tor.InChandraetal.(1989)theauthorsshowthatthecommutetimebetweentwonodess,tinagraphisproportionaltotheeffectiveresistancebetweensandt.Sinceadditionordeletionofafewedgesusuallydonotchangetheelectricalpropertiesofanetworksub-stantially,theaboverelationmakesiteasytoseethatcommutetimesarealsorobusttominorperturbationofthegraphstructure.Wegiveaverysimplebutintuitiveexample.ConsideraundirectedunweightedgraphG.Weselectanynodecandaddlinksfromctoallothernodesinthegraph.Leti,andjbeanytwonodes,s.t.i(cid:54)=j(cid:54)=c.Ashortestpathbetweeniandjbecomes2hopsnow.Howeverthehittingtimehijhardlychanges.Ifaran-domwalkstartingatihitsc,thenthereisaverysmallchanceofhittinganyothernodefromc,since∀jpc,j=1/(n−1).Hencethehittingtimesbetweenthenodesinthegraphstayalmostthesame.Thispropertyisverydesirablesinceinmostreal-worlddata-setstherearespuriouslinksresultingfromerro-neousobservations.Wealsodemonstratethisusingasimulateddatasetintheexperimentalsection.3RelatedWork3.1ApplicationsTherandomwalksapproachhasbeenhighlysuccessfulinsocialnetworkanalysis(Katz,1953)andcomputervision(Gorelicketal.,2004;Qiu&Hancock,2005).Herewebrieflydescribesomeoftheseapplications.Saerensetal.(2004)exploitequation(1)toembedagraphandprovidedistancesbetweenanypairofnodes.Yenetal.(2005)replacetraditionalshortest-pathdistancesbetweennodesinagraphbyhittingandcommutetimesandshowthatstandardclusteringal-gorithms(e.g.K-means)producemuchbetterresultswhenappliedtothesere-weightedgraphs.Thesetech-niquesexploitthefactthatcommutetimesareveryrobusttonoiseandprovideafinermeasureofclustercohesionthansimpleuseofedgeweight. SARKAR & MOORE 337 Gorelicketal.(2004)usetheaveragehittingtimeofarandomwalkfromanobjectboundarytocharacterizeobjectshapefromsilhouettes.GradyandSchwartz(2006a)introducedanovelgraphclusteringalgorithmwhichwasshowntohaveaninterpretationintermsofrandomwalks.Hittingtimesfromallnodestoades-ignatednodewerethresholdedtoproducepartitionswithvariousbeneficialtheoreticalproperties.GradyandSchwartz(2006b)usedtheaboveapproachforau-tomatedimagesegmentation.AlsoQiuetalhaveusedcommutetimesclusteringforrobustmultibodymotiontracking(Qiu&Hancock,2006)andimagesegmenta-tion(Qiu&Hancock,2005).Commutetimesandhittingtimeshavebeensuccess-fullyusedforcollaborativefiltering.InBrand(2005)theauthorsusedifferentmeasuresresultingfromran-domwalkstorecommendproductstousersbasedontheirpurchasehistory.Theauthorsgiveempiricalev-idenceofthefactthathittingandcommutetimesoftenaresmallifoneofthenodeshasahighdegree.whereasthecosinesimilarity(definedinSection2)doesnothavethatproblemsinceinsomesensetheeffectofindividualpopularityisnormalizedout.Givenasnapshotofasocialnetwork,averyinterestingquestionis:whichnewconnectionsamongentitiesarelikelytooccurinthefuture?InLiben-NowellandKleinberg(2003)differentproximitymeasuresbetweennodesinagraphareusedforlinkpredictiontasksonsocialnetworks.Theauthorsshowedthatthehittingandcommutetimessufferfromthefactthattheytakeintoaccountinformationfromlongpaths.ThemosteffectivemeasurewasshowntobetheKatzmeasure(Katz,1953)whichdirectlysumsoverthecollectionofpathsbetweentwonodeswithexponentiallydecayingweightssothatsmallpathsaregivenmoreweight.However,computingthisforallpairsofnodesneedsatleastO(n2)timeandstorage.3.2ComputationMostclusteringapplicationseitherrequireextensivecomputationtoproducepairwiseproximitymeasures,oremployheuristicsforrestrictingthecomputationtosubgraphs.Saerensetal.(2004)computethetrailingeigenvectorsofLtoreconstructL+.ThisstillrequiresatleastO(n2)computationandstorage.Cubiccomputationisavoidedbyusingsparsematrixmanipulationtechniques.InBrand(2005)theauthorstrytocomputesub-matricesofHandCbyiterativesparsematrixmultiplications.NotethatcomputingtheithrowofC,i.e.C(i,∗)orthecosine-similaritiesofalljwithirequiresl+jj,∀j.Theexactvalueofl+jjre-quiressolvinglinearsystemsofequationsforallotherrowsofL+.Theauthorsstatethatforlargemarkovchainsthesquareoftheinversestationarydistribu-tionofjisacloseconstantfactorapproximationtol+jj,whichisfairlyloose.Inshort,itisonlytractabletocomputethesemeasuresongraphswithafewthou-sandnodesformostpurposes.Themainproblemwithcomputinghittingtimesisthatitseasytocomputeeverynode’shittingtimetoasinglenode,i.e.onecolumnofthehittingtimematrixusingdynamicprogrammingapproaches.Howeveritshardtocomputethehittingtimefromonenodetoeveryothernode.Forthatonewillhavetoeffectivelycomputetheentriesofanentirecolumninordertogetasingleentry.Thisproblemcanbereducedtotheproblemoffindingalldiagonalelementsofthepseudo-inverseofthegraphLaplacianwithoutcomputingtheentirepseudo-inverse.3.3Othergraph-basedproximitymeasuresSpectralclustering(Ngetal.,2001)isabodyofal-gorithmsthatclusterdatapointsxiusingeigenvectorsofamatrixderivedfromtheaffinitymatrixWcon-structedfromthedata.OftenwijisobtainedfromtheEuclidiandistancebetweenthedatapoints,i.e.wij=exp((cid:107)xi−xj(cid:107)2/σ2),whereσisafreeparam-eter.Zhuetal.(2003)usesgraphtheoreticapproachforsemi-supervisedlearning.Givenlabeledandunla-beleddata-pointsasnodesinagraph,themaingoalistoexploitthegraphstructuretolabeltheunlabeledexamplesusingthefewlabeledones.4TheAlgorithmInthissectionwepresentanovelalgorithmtocomputeapproximatenearestneighborsincommutetimeforallnodes,withoutcomputingtheentirematrix.4.1TruncatedHittingtimesHittingandcommutetimesdecreaseiftherearemanyshortpathsbetweenthenodes.Ontheotherhand,asobservedbyLiben-NowellandKleinberg(2003),twomajordrawbacksarethattheytendtobesmallwhen-everoneofthenodeshasahighdegree,andtheyarealsosensitivetopartsofthegraphfarawayfromthenodes,evenwhenshortpathsbetweenthenodesexist.InordertoovercometheseproblemswedefineaT-truncatedhittingtime,whereweonlyconsiderpathsoflengthlessthanT.InSection5weshowthathTapproachesthetruehittingtimeasT→∞.Weuseh,htinterchangeablytodenotetruncatedhittingtime.TheTtruncatedhittingtimei.e.hTijfromitoj,mea-surestheexpectednumberofstepstakenbyarandomwalkstartingatnodeitohitjforthefirsttime.ItcanalsobedefinedrecursivelyashTij=1+(cid:88)kpikhT−1kj(2) 338 SARKAR & MOORE BGFigure1:Neighborhoodofnodej.Adirectedgraphisdrawnforclarity.wherehTisdefinedtobezeroifi=jorifT=0.TheaboveequationexpresseshTinaonesteplook-aheadfashion.Theexpectedtimetoreachadesti-nationwithinTtimestepsisequivalenttoonestepplustheaverageoverthehittingtimesofit’sneigh-borstothedestination.Equation(2)canbeeasilycomputedbyusingGaussSeideliterations.LetthetruncatedhittingtimesmatrixbeHT.Notethatthehittingtimefromallnodestoafixeddestination,i.e.acolumnofHTcanbecomputedinO(T∆n)time,where∆istheaveragedegreeofanode.Howeverifweneedtocomputethehittingtimefromonenodetoeveryoneelse,i.e.arowofHT,HT(i,∗)then∀jwewillcomputethecorrespondingcolumninordertogetoneentryHT(i,j).Henceweshallendupcomputingtheentirematrix.Insteadofexaminingallpairsofnodeswedevelopaveryefficientframeworkfordoingarange-searchtoretrievethekapproximatenearestneighborsofallnodesinagraph.4.2GRANCHThemainintuitionisthatwethinkaboutthegraphintermsofnoverlappingsubgraphs.Eachsubgraphisaboundedneighborhoodforonenode(discussedindetaillaterinthesection).Considerthehittingtimesarisingfromtherandomwalkfromanynodeinthisneighborhoodtothedestination.Weprovideupper(pessimistic)andlower(optimistic)boundsofthesehittingtimes,andshowhowtocombineinformationfromalltheseoverlappingsubgraphstoobtainknear-estneighborsforallnodes.Wewillusetheterms“op-timistic”and“lower”,and“pessimistic”and“upper”,interchangeably.InordertomotivatetheGRANCHalgorithmwepresentthefollowingclaimbeforefor-mallydescribingthealgorithm.Claim:Givenk,,TandT(cid:48)≤T,GRANCHreturnsanykneighborsjofi∀i,s.t.cT(i,j)≤cT(i,ki,T(cid:48))(1+),whereki,T(cid:48)isthetruekthnearestneighborofiwithinT-truncatedhittingtimeT(cid:48).Thismakessensesinceinallapplicationshittingandcommutetimesareusedforrankingentities,e.g.rec-ommendthekbestmoviesbasedonchoicesalreadymadebyanuser;or,findthekmostlikelyco-authorsofanauthorinaco-authorshipnetwork.SupposewewanttoestimatehTijforpairsofnodesi,jwhichhaverelativelylowhTijvalues,andsupposewewanttoavoidO(n2)timeorspacecomplexity.There-forewecannotdoanythingthatrequiresrepresentingoriteratingoverallpairsofnodes.Infact,wecan-notevenaffordtoiterateoverallpairsofnodesthatarelessthanThopsapart,sinceingeneralthenum-berofsuchpairsisO(n2).Supposewerestrictcom-putationtoiterateonlyoversomesubsetofpairsofnodes,whichwewillcalltheActive-Pairs-setortheAPset.TheinterestingquestionishowgoodarethepessimisticandoptimisticboundswecangetonhTij,∀i,jusingonlyO(AP)work?Asmentionedbeforewewillconsiderboundedneigh-borhoodsofeachnodeinthegraph.Forclarity,incaseofadirectedgraphtheneighborhoodconsistsofallnodeswithshortpathstothedestinationnode.Hereisouralgorithminanutshell:foreachnode,wewillstartwiththedirectneighborsinitsneighbor-hood,andthencomputetheoptimisticandpessimisticboundsonhittingtimesofthenodeswithinaneigh-borhoodtothatnode.Wewillthenexpandtheneigh-borhoodandre-iterate.Theboundswillbetighterandtighteraswekeepexpandingtheneighborhoods.DefinethesetAPasasetofpairsofnodessuchthatifiisintheneighborhoodofj,then(i,j)∈AP.Notethat(i,j)∈APdoesnotimplythat(j,i)∈AP.Eachneighborhoodofnodeihasaboundary,δi,suchthataboundarynodeontheneighborhoodofjhasdirectneighborsoutsidetheneighborhood.Againinadi-rectedgraphaboundarynodehasoutgoingedgestonodesoutsidetheneighborhood.Let’sfirstassumethattheneighborhoodisgiven.It’sclearfromtheexpressionfortruncatedhittingtimethathijcanbecomputedfromthehittingtimeofi’sneighborstoj.InFigure1therandomwalkfromicanhiteitherofit’sneighborsGorB.SinceGisinsidetheneighborhoodofjwealreadyhaveanestimateofhGj.HoweverBisoutsidetheneighborhoodofj,andhencewefindtheoptimisticandpessimisticvaluesofhBj,resultingintolowerbounds(hoij)andupperbounds(hpij)ofhij.Theoptimisticboundisobtainedbyallowingtherandomwalktojumptotheboundarynodewithclosestoptimistichittingtimetoj,andthepessimisticboundarisesfromthefactthatthewalkmightnevercomebacktotheneighborhoodafterleavingit,i.e.takesTtime.Nowwerevisitthedata-structuresintermsoftheirnotations.WedenotethesetofactivepairsasAP. SARKAR & MOORE 339 AP(∗,i)isthesetofnodesk,s.t.(k,i)∈AP.HencetheneighborhoodoficanalsobedenotedbyAP(∗,i).Alsoδ(i)isthesetoftheboundarynodesoftheneigh-borhoodofi,i.e.AP(∗,i).Letnbs(i)denotethesetofdirectneighborsofi.AlsodenotebyGnbs(i,j)thesetAP(∗,j)∩nbs(i).Theupperandlowerboundsare:hpTij=1+(cid:88)k∈Gnbs(i,j)pikhpT−1kj+1−(cid:88)k∈Gnbs(i,j)pik(T−1)(3)hoTij=1+(cid:88)k∈Gnbs(i,j)pikhoT−1kj+1−(cid:88)k∈Gnbs(i,j)pik(cid:181)1+minp∈δ(j)hoT−2pj(cid:182)(4)Wecanalsouseatighterboundthantheabovebyus-ingonesteplookaheadfromthenodesonthebound-ary,whichisomittedforspacepurposes.ThehoandhpvaluesofallnodesinAP(∗,j)tojcanbecomputedusingtheGauss-Seideltechnique,asinAlgorithm4.2.Afterobtainingtheboundsonthehittingtimesbe-Algorithm1:compute-H(dst,AP,G,T)1:ho,holast,hp,hplast←ones(1:N)12:minvals0:T←0;minvals1=13:fort=2toTdo4:min←∞5:forsrc∈AP(∗,dst)do6:s1,s2←0,prob←07:fori∈nbs(src)do8:ifi∈AP(∗,dst)then9:s1←s1+psrc,iholast(i)10:s2←s2+psrc,ihplast(i)11:prob←prob+psrc,i12:endif13:endfor14:ho(src)←1+s1+(1−prob)(1+minvalst−2)15:hp(src)←1+s2+(1−prob)(t−1)16:ifho(src)≤min&src∈δ(dst)then17:min←ho(src)18:endif19:endfor20:minvalst←min21:holast←ho22:hplast←hp23:endfortweenallpairsintheAP-set,wecanobtainboundsonhittingtimesasfollows:hoij=(cid:40)hoijifi∈AP(∗,j)1+minp∈δ(j)hoT−1pjelse1Notethat∀i,jh1(i,j)=1.hpij=(cid:40)hpijifi∈AP(∗,j)TelseNotethatweareexplicitlygivingtheexpressionsforallpairsofnodesinthegraphforclarity.HowevertheboundsneedonlyO(AP)space.Usingtheabovewealsogetoptimisticandpessimisticboundsoncommutetimes,namelycoandcp.coij=hoij+hoji;cpij=hpij+hpji(5)4.3ExpandingNeighborhoodSincetimeandspacecomplexityofGRANCHisO(AP),wehavetobecleverinhavingtherightsetofpairsintheAPset,inordertoavoidwastingcom-putationonnodesthatareveryfarapart.Wepresentaneighborhoodexpansionschemewhichwillguaranteethatwedonotmissanypotentialnearestneighbors.Wealsonotethataddingnodestotheneighborhoodoficanonlytightenthebounds.Theorem4.1TheoptimisticboundsonH,i.e.hovaluescanonlyincrease,andthepessimisticbounds,i.e.hpvaluescanonlydecrease,asaresultofaddingnodestotheAPset.Proof:ThehittingtimeforanodeoutsidetheAP-setmustbeatleasttheminimumhittingtimetotheboundaryoftheAP-set,plustheminimumhittingtimefromtheboundarytothedestination.Forades-tinationnodej,hoT−1m,j≥1+minp∈δ(j)hoT−2pj,∀m(cid:54)∈AP(∗,j).HencehoTijin(4)isindeedavalidlowerboundonhTij.Thereforeitcanneverdecrease.Thepessimisticboundin(3)isvalid,sincehtij≤t∀i,j,byconstructionofht.Hencethepessimisticboundscanneverincrease.Definition:Definethelowerboundoftheneighbor-hoodofnodeiaslb(i)=1+minp∈δ(i)hoT−1pi.Lemma4.2ThelowerboundonhittingtimeofnodesoutsidetheAP-setofnodei,i.e.lb(i),canonlyin-creaseasaresultofaddingnodestotheAPset.Proof:ThisisadirectapplicationofTheorem4.1.Westartwithalldirectneighborsofthedestinationnodei.Notethatallnodesoutsidetheboundarywilltakeatleast1+minp∈δ(i)hoT−1pitimetoreachi.Letusdenotethisbylb(i).AlsorememberthatwearedoingarangesearchofallneighborswithinarangeT(cid:48)<T.Wewanttoincreasethislowerbound,sothatwecanguaranteethatweshallneverleaveoutapotentialnearestneighbor.Theoptimalwaytoincreasethe 340 SARKAR & MOORE Algorithm2:Expand-AP(G,T,T(cid:48))1:Initialize2APwithallpairsi,j∈EG2:fori=1toNdo3:whilelb(i)≤T(cid:48)do4:compute-H(i,AP,G,T)5:lb(i)←1+minp∈δ(i)hoT−1pi6:q←argminp∈δ(i)hoT−1pi7:AP←AP∪{(a,i):a∈nbs(q)}8:endwhile9:endfor Lower and Upper bounds of truncated hitting timesNeighbors of i ordered by increasing lower bounds of truncated hitting times XX(1+ε)BBFigure2:UpperandlowerboundsofhT(i,∗)lowerboundistoaddintheneighborsofq,whereq=argminp∈δ(i)hoT−1pi.Lemma4.3Ifi(cid:54)∈AP(∗,j)afterrunningAlgorithm2,thenhij≥T(cid:48).Afterrunningalgorithm2,hoi,j≥lb(j)≥T(cid:48).Alsobyconstructionwehavehi,j≥hoij.4.4ApproximateNearestNeighborsWeshallfirstlookathowtoobtainthek-approximatenearestneighborsforeachnodeinhittingtime.Laterweshalldemonstratehowtoextendthattoapproximatenearestneighborsincommutetimes.Notethatweonlyhaveupperandlowerboundsonhittingtimesfromanodetoothernodes.Thekeyideaisthatanyvaluexwillbesmallerthanyiftheupperboundofxissmallerthatthelowerboundofy.4.4.1TruncatedhittingtimeWeillustratewithatoyexample.LetsassumethatwewanttofindtheknearestneighborsofnodeiwithinT(cid:48).InFigure2weplotthelowerandupperboundsofhi,j,intheorderofincreasinglowerbounds.Itwill2TheAP-setcanbeinitializedtoallpairswithinphopstoo.Weusedp=2forsomeofourexperiments.sufficetofindallnodesj,s.t.hpijissmallerthanthehvalueofthe(k+1)thtruenearestneighbor.Notethatthe(k+1)thnearestneighbor’shittingtimeisgreaterthanthe(k+1)thlargesthovalue.Hencetheupper-boundbecomesX=(k+1)thlargesthoi,∗.NowwealsoallowasmallerrormarginofleadingtoanewupperboundX(1+).Allentitieswithupperboundlessthanthisareguaranteedtobe-approximate.WealsowanttheneighborstobewithinT(cid:48)hittingtimeofthesourcei.Hencewefindthelargestk(cid:48)≤k+1,s.t.hoik(cid:48),i≤T(cid:48)andhpik(cid:48),i≥T(cid:48),whereik(cid:48)isthenodewiththek(cid:48)thlargesthovaluefromi.NowtheupperboundXbecomesX=hoi,ik(cid:48).Wereturnallnodesx,s.t.hpi,x<X(1+).ThereforeinFigure2wehavek=15,k(cid:48)=10.Thismeansthatatthispointtheboundsarenottightenoughtodeterminetheexactranksofthek−k(cid:48)neighbors.AllthenodeswithlowerboundsbeyondT(cid:48)areguaranteednottobewithinT(cid:48).ThenodeslabeledBarenotguaranteedtobeapproximateandarenotreturned.4.4.2TruncatedcommutetimeNowwelookattheneighborsincommutetimes.Thenewdistanceforrange-searchbecomes2T(cid:48).Foranynodei,wenowlookatallnodesinthesetAP(i,∗)∪AP(∗,i).AP(i,∗)denotesthesetofallnodesthathaveiintheirneighborhoods.Afterrun-ningAlgorithm2,ifthereexistssomenodej,s.t.j(cid:54)∈AP(∗,i)andi(cid:54)∈AP(∗,j),thenbyLemma4.3,ho(i,j),ho(j,i)≥T(cid:48)andhenceco(i,j)≥2T(cid:48),sojcannotbewithinacommutedistanceof2T(cid:48)ofi.Wecomputethenearest-neighborsfornodei,i∈{1:n}usingtheAPsetresultingfromAlgorithm2.Nowwefindthenearestneighborsofiincommutetimesusingequation(5).NotethatweonlylookatthenodesinsetSi=AP(i,∗)∪AP(∗,i).Sortallthenodesinincreasingorderofoptimisticboundsi.e.covalues.Let{i1,i2,...}denotetheindexesofthesortednodes.Letk(cid:48)thelargestintegerlessthank,s.t.co(i,ik(cid:48))≥2∗T(cid:48).Ifsuchak(cid:48)existsdefineXas2∗T(cid:48).Otherwiseclearlyallkpossiblenearestneighborsmightbewithintherange.HencedefineXasco(i,ik).Returnanynodej∈Sis.t.cp(i,j)≤X(1+).AlsoletBbethesetofnodesbinSis.t.co(i,b)≤X,butcp(i,b)≥X(1+).Clearlythesenodescannotbeguaranteedtobeamongtheknearestneighbors.NowweexpandtheAP-setsof{i}∪Btotightentheboundsmore.Becauseoftheconstructionofthealgorithm,thenewlyintroducednodescanneveraffectk(cid:48),andtheothernearestneighbors.ByLemma4.3,wewillneverintroduceanewpossiblenearestneighborofanodeb∈{i}∪B,sinceallnodesoutsideSbareguaranteedtohavecommute-distanceworsethan2T(cid:48).AlsoanexpansionoftheAP-setcanonlyincreasethelower SARKAR & MOORE 341 bounds,anddecreasetheupperboundsontheesti-matesonhittingtimes,whichwillneverdecreasethenumberofneighborsreturnedsofar.Hencewewillonlyimprovetheperformanceofthealgorithmbyex-pandingourAP-setbeyondalgorithm2.GRANCHusesAlgorithm2tobuildtheAP-setandthencomputesthek-approximatenearestneighborsintruncatedcommutetime.5TruncatedandTrueHittingTimesInthissectionweexaminetherelationbetweenthetrueandtruncatedhittingtimes.LetPbethesetofpathsbetweeni,j,suchthatjappearsonlyonceinthepath.LetPtbeallsuchpathsoflengthexactlyt.SoP=(cid:83)tPt.Wecanthenexpressthetruncatedhittingtimeasanexpectedpathlength:hTij=E(P)=T−1:t=1tPr{it−→j}+(1−:tPr{it−→j})TWherePr{it−→j}denotestheprobabilitythatireachesjforthefirsttimeinexactlytsteps.DefinePasamatrixidenticaltoP,exceptforthejthrow.∀mP(j,m)=0.Henceaftertherandomwalkhitsjfromi,thereisalossofprobabilitymassfromthesystem,whichiswhythesumisbounded.ThusPr{it−→j}=Pti,j.Substitutingintheaboveequation:hTij=T−1(cid:88)t=1tPtij+(1−T−1(cid:88)t=1Ptij)TNotethatasT→∞theprobabilityofinotreachingjgoestozeroifthegraphisconnected.Hencetheabovegetsreducedtothetruehittingtime.TherateatwhichtheT-truncatedhittingtimeap-proachesthetruehittingtimedependsonthemixingtimeofarandomwalkonthegraph.Themixingtimeequalsthenumberofstepsbeforetherandomwalkconvergestothestationarydistribution.Itisthein-verseofthemixingrate(Lovasz,1996)whichmeasureshowfastthedistributionapproachesthestationarydistribution.ThiscanbeeasilycomputedfromtheeigenvaluesofthegraphLaplacian.Onewayofset-tingthevalueofTdynamicallywillbebyevaluatingthemixingtime.Foragraphwithasmallmixingtime,Tshouldbesmall,sinceafterafewstepsthedistributionbecomesindependentofthestartnode.6ExperimentsWepresentourexperimentsintwoparts.Firstwepresentresultsonsimulateddata.Thenwegivere-sultsfromlargerealworlddata-setsextractedfromtheCiteseerco-authorshipnetwork.Weuselink-predictiontaskstoevaluatethecommutetimesresult-ingfromGRANCH.Linkpredictionisaveryimpor-tantandfairlyhardtaskinsocialnetworkanalysis.Theideaistopredictpossibleinteractionsbetweenentitiesbasedonthestructureofthenetwork.WepresentperformancesofGRANCHandabaselinealgorithm,alongwiththenumberofpairsofnodesex-aminedbyboth.Thebaselinealgorithmweuseisthenumberofhopsbetweentwonodes,forwhichwedoasimpleBreadthFirstSearchfromthenodeupto4hops,anddefineeverythingbeyondas5hops.Sincesocialnetworkdatasetsexhibittransitivesocialtrends,thisseeminglynaivebaselineisoftenhardtobeat.Itisusedbymanyonlinefriendshipnetworksforrec-ommendingfriends.Forthesmallsimulatedgraphswealsocomputedtheexacttruncatedcommutetime,whichneededallpairsofnodes.OurresultsshowthattheperformanceofGRANCHiscomparabletotheex-actversion,evenifitlooksatsmallfractionofallpairsofnodes.Italsoperformsbetterthanthebaseline,andneedstoexaminemuchsmallernumberofpairs.Hereisabriefdescriptionoftheexperimentalmethod-ology.Weremovearandomsubsetoflinksfromtheoriginalgraph.Nowwecomputethe2T-truncated-commutetimesonthetraininglinks.Therankinginducedbythisistestedagainsttheheldoutlinksus-ingtheirAUC-scores.Weonlytakenodeswhichhasatleastonelinkheldout.Foreachsuchnodewetaketheproximitymeasuresfromthealgorithmsofallnodeswithin4hopsofthesourceintheoriginalgraph(notallothernodes)andcomputetheAUCscoreofthatvector.WepresenttheaverageAUCscore.WedenotetheexactcommutetimebyC.WealsocompareouralgorithmfordifferentvaluesofT,3,6,10.FormostofthegraphswenoticedthatT=6wasenough.Tinalltablestranslatestoa2T-truncatedcommutetime.Wealsosawthatasweincreaseourrangeofsearch,i.e.T(cid:48)wegetclosertotheaccuraciesoftheexacttruncatedhittingtimes.AtypicalchoiceofT(cid:48)is2.9forT=3,5.95forT=6,and9.75forT=10.WepresentthetotalnumberofpairsintheAP-setforGRANCHinTables2and4.Thesetablesalsoshowthetotalnumberofpairsthebaselineneedstolookatwhileexaminingallnodeswithatleastoneedgeheldout.ThisisbecausewecomputeAUCscoresforonlythesenodes.Wealsoputthetotalnumberofpairswithin4hopsfortheCiteseergraphsinTable5.Thetotalnumberofpairsforthebaselinecanbeasmuchasthesenumbersintheworstcase.6.1SimulatedDataAgraphGcanbequantifiedintermsofitsgrowthrateρG(Krauthgamer&Lee,2003).ρGisdefinedastheminimumρ,s.t.everyballofradiusr>1inGcontainsatmostO(rρ)nodes.Bydefinition,thisimpliesthatthetotalnumberofnodeswithinchops 342 SARKAR & MOORE Table1:AUCscoreon30%linksheldoutfromgraphsofsizen,edgese,growth-ratedforalgorithmsC,GRANCHwithT=10,T=6,T=3andthebaseline(numberofhopsbetweennode-pairswithin4hops).dneC,T=10GRANCH,T=10C,T=6GRANCH,T=6C,T=3GRANCH,T=3Baseline21,000270082.482.482.48271716941,000270085838583686874210,00027,000-82.2-83-7370.6410,00027,000-80-80-6673Table2:Ontrainingsetof70%linksfromsimulatedgraphsofdimensiond,sizen,edgese,numberofpairsinAP-setofGRANCHandnumberofpairsexaminedbyalgorithmC(withT={10,6,3})andthebaseline.dneC,T=10GRANCH,T=10C,T=6GRANCH,T=6C,T=3GRANCH,T=3Baseline21,0002,7001M24,5941M29,6561M13,52134,90241,0002,7001M47,8461M45,6231M14,83972,646210,00027,000-257,110-311,944-141,136381,564410,00027,000-503,998-478,409-170,144781,515ofanynodeisatmostO(cρG).Forexamplethe2Dgridgraphhasρ=2,andingeneralakdimensionalhypergridhasρ=k.Wegenerategraphsofgrowth-rated,byassigningddimensionalEuclidiancoordinatestothenodes,andaddinglinksbetweencloseneighborsplussomelongdistancelinks.Thisbringsabouttheveryfamoussmallworldphenomenon(Milgram,1967).Wedothefollowingexperiments,1.AUCscoresonheldoutdata2.AUCscoresondatawithnoisylinksWeonlypresenttheperformanceoftheexacttrun-catedcommutetimeforthe1,000-nodegraph,sincethecomputationbecomestooexpensiveforthe10,000-nodegraph.AsinTable1,ouralgorithmbeatsthebaselinealgorithm,anddoesalmostaswellastheexacttruncatedcommutetime(forthe1000nodegraph)withoutlookingatallpairsofnodes.AlsofromTable2wecanseehowforagivennumberofnodesandedgesthedimensionalityofthegraphaffectsthenumberofpairsneededbybothGRANCHandthebaselinealgorithm.NoisyData:Wegenerateanexamplewherewemakeadatasetnoisybyaddinglinksfromarandomlycho-sennodeto20%oftheremainingnodes.Nowweholdout30%linksfromthisgraph,andtesttheAUCscoreofouralgorithm.Weexpecttoseethatthecommutetimesoutperformthebaseline,sinceit’smuchmorero-busttonoise.Fora100-nodegraph,GRANCHwithT=6hasanAUCscoreof85.3%,whereasthenumberofhopshasanAUCscoreof70.23%.6.2RealworldgraphsInthissectionweperformsimilarexperimentsasinthelastsectiononrealworldgraphs.Weusesub-setsoftheCiteseernetworkofsizes:20,000nodeswith55,000edges,50,000nodeswith160,000edgesand100,000nodeswith280,000edges.Thesegraphsareconnectedbutsparse.Wepresentthetotalnumberofpairswithin4hopsofoneanotherinthetraininggraphsintable5.Thesenumbersreflectthesmallworldphenomenoninreal-worldsocialnetworks.Ev-erynodecanreacheveryothernodewithinafewhops.ThisalsoemphasizesthefactthatitsnotevenfeasibletotakeallnodeswithinThopstocomputethetrun-catedcommutetimesexactly.ForreasonablevaluesofT,theabovewillbeahugefractionofallpairs.Table5:Numberofpairswithin4hopsintraininggraphs(90%linksfromCiteseer)ofdifferentsizes.ne#ofpairswithin4hops19,47754,4073,401,81252,033152,51820,478,196103,500279,43588,418,488Weremovearandomlychosen10%ofthelinkstoob-tainthetrainingandtestgraphs,withthesameset-tingofT(cid:48).Forthesedatasets,theexacttruncatedcommutetimeisintractable.InTable4notethatthebaselinehastocomputehopsbetweennumberofpairsthatismorethatoneorderofmagnitudelargerthanthenumberofpairsconsideredbyGRANCH.AlsothenumbersinTable4areonlyforthenodeswhichhadat SARKAR & MOORE 343 Table3:AUCscoreofGRANCHandthebaselineon10%linksheldoutfromgraphsofsizen,edgesewithT=10;T=6;T=3neGRANCH,T=10GRANCH,T=6GRANCH,T=3Baseline19477544078280787452033152518858478.67910350027943586.7867983Table4:Onthetrainingsetof90%linksfromgraphsofsizen,edgese,numberofpairsinAP-setofGRANCHwithT=10;T=6;T=3;andnumberofnode-pairsusedbythebaseline.neGRANCH,T=10GRANCH,T=6GRANCH,T=3Baseline19,47754,407600,000335,769279,7361,336,68352,033152,5182,017,9311,532,534293,3668,723,436103,500279,4355,143,9824,156,7921,661,59840,563,881leastoneedgeheldoutfromtheoriginalgraph.IntheworstcasethesenumberscouldbeaslargeasinTa-ble5.Thebaselinealgorithmperformsquitewellforthesedatasetsindicatingexistenceoftransitivetrendsinco-authorshipnetworks.7ConclusionandFutureWorkThispaperhasaddressedanimportantgapingraphproximitymeasures:thattheimportantmeasuresarealsothehardesttocompute.Wedesignedanalgo-rithmthatguaranteesan-errorandshowedempiri-callythatitavoidsO(n2)computationorstorageinpracticewhileretainingthepredictiveperformanceoftheexpensivecommutetimemethods.Forfuturedirectionswewillliketoanalyzetherun-timeofGRANCH.Wewouldalsoliketodoadetailedcomparisonofouralgorithmwithdifferentlinkpredic-tionalgorithms.CurrentlywesettheparameterTfortruncationatdifferentvaluestohavedifferentbehav-iorofthealgorithm.ItwouldbeinterestingtochooseTdynamicallybasedonthemixingtimeofthegraph.8AcknowledgementsWeareverygratefultoJeremyKubicaforhishelpfulcom-mentsandsuggestions.ThisworkwasdonewhilethefirstauthorwasaninternatGooglePittsburgh.ReferencesAldous,D.,&Fill,J.A.(2001).Reversiblemarkovchains.Brand,M.(2005).ARandomWalksPerspectiveonMax-imizingSatisfactionandProfit.SIAM’05.Chandra,A.K.,Raghavan,P.,Ruzzo,W.L.,&Smolensky,R.(1989).Theelectricalresistanceofagraphcapturesitscommuteandcovertimes.STOC’89(pp.574–586).Doyle,P.G.,&Snell,J.L.(1984).Randomwalksandelectricnetworks.TheMathematicalAssoc.ofAmerica.Gorelick,L.,Galun,M.,Sharon,E.,Basri,R.,&Brandt,A.(2004).Shaperepresentationandclassificationusingthepoissonequation.CVPR.Grady,L.,&Schwartz,E.L.(2006a).Isoperimetricgraphpartitioningfordataclusteringandimagesegmentation.IEEEPAMI.Grady,L.,&Schwartz,E.L.(2006b).Isoperimetricparti-tioning:Anewalgorithmforgraphpartitioning.SIAMJournalonScientificComputing.Katz,L.(1953).Anewstatusindexderivedfromsocio-metricanalysis.Psychometrika.Krauthgamer,R.,&Lee,J.R.(2003).Theintrinsicdi-mensionalityofgraphs.ProceedingsoftheSTOC’03.Liben-Nowell,D.,&Kleinberg,J.(2003).Thelinkpredic-tionproblemforsocialnetworks.CIKM’03.Lovasz,L.(1996).Randomwalksongraphs:asurvey.Milgram,S.(1967).Thesmallworldproblem.PsychologyToday.Ng,A.,Jordan,M.,&Weiss,Y.(2001).Onspectralclus-tering:Analysisandanalgorithm.Qiu,H.,&Hancock,E.R.(2005).Imagesegmentationusingcommutetimes.Proc.BMVC.Qiu,H.,&Hancock,E.R.(2006).Robustmulti-bodymo-tiontrackingusingcommutetimeclustering.ECCV’06.Saerens,M.,Fouss,F.,Yen,L.,&Dupont,P.(2004).Theprincipalcomponentanalysisofagraphanditsrelation-shipstospectralclustering.Smola,A.,&Kondor,R.(2003).Kernelsandregulariza-tionongraphs.Yen,L.,Vanvyve,L.,Wouters,D.,Fouss,F.,Verleysen,F.,&Saerens,M.(2005).Clusteringusingarandom-walkbaseddistancemeasure.Zhu,X.,Ghahramani,Z.,&Lafferty,J.(2003).Semi-supervisedlearningusinggaussianfieldsandharmonicfunctions.
1707.04044
2
1707
2017-11-15T18:36:38
Distinguishing humans from computers in the game of go: a complex network approach
[ "cs.SI", "cs.CY", "physics.soc-ph" ]
We compare complex networks built from the game of go and obtained from databases of human-played games with those obtained from computer-played games. Our investigations show that statistical features of the human-based networks and the computer-based networks differ, and that these differences can be statistically significant on a relatively small number of games using specific estimators. We show that the deterministic or stochastic nature of the computer algorithm playing the game can also be distinguished from these quantities. This can be seen as tool to implement a Turing-like test for go simulators.
cs.SI
cs
epl draft 7 1 0 2 v o N 5 1 ] I S . s c [ 2 v 4 4 0 4 0 . 7 0 7 1 : v i X r a Distinguishing humans from computers in the game of go: a com- plex network approach C. Coquid´e1, B. Georgeot1 and O. Giraud2 1 Laboratoire de Physique Th´eorique, IRSAMC, Universit´e de Toulouse, CNRS, UPS, 31062 Toulouse, France 2 LPTMS, CNRS, Univ. Paris-Sud, Universit´e Paris-Saclay, 91405 Orsay, France PACS 89.20.-a -- Interdisciplinary applications of physics PACS 89.75.Hc -- Networks and genealogical trees PACS 89.75.Da -- Systems obeying scaling laws PACS 01.80.+b -- Physics of games and sports Abstract -- We compare complex networks built from the game of go and obtained from databases of human-played games with those obtained from computer-played games. Our investigations show that statistical features of the human-based networks and the computer-based networks differ, and that these differences can be statistically significant on a relatively small number of games using specific estimators. We show that the deterministic or stochastic nature of the computer algorithm playing the game can also be distinguished from these quantities. This can be seen as tool to implement a Turing-like test for go simulators. Introduction. -- Computers are more and more present in everyday life, and they often perform tasks that were previously reserved to human beings. In particular, the raise of Artificial Intelligence in recent years showed that many situations of decision-making can be handled by computers in a way comparable to or more efficient than that of humans. However, the processes used by comput- ers are often very different from the ones used by human beings. These different processes can affect the decision- making in ways that are difficult to assess but should be explored to better understand the limitations and advan- tages of the computer approach. A particularly spectac- ular way of testing these differences was put forward by Alan Turing: in order to distinguish a human from a com- puter one could ask a person to dialog with both anony- mously and try to assess which one is the biological agent. As the question of human-computer interaction gets more pregnant, there is an ever growing need to understand these differences [1]. Many complex problems can illus- trate the deep differences between human reasoning and the computer approach. Board games such as chess or go, which are perfect-information zero-sum games, provide an interesting testbed for such investigations. The complex- ity of these games is such that computers cannot use brute force, as in complex decision making, and have to rely on refined algorithms from Artificial Intelligence. Indeed, the number of legal positions is about 1050 in chess and 10171 in go [2], and the number of possible games of go was recently estimated to be at least 1010108 [3]. This makes any exhaustive analysis impossible, even for machines, and pure computer power is not enough to beat humans. In- deed, the most recent program of go simulation AlphaGo [4] used state of the art tools such as deep learning neural networks in order to beat world champions. Various approaches were considered to overcome the vastness of configuration space. A cornerstone of the com- puter approach to board games is a statistical physics treatment of game features. A first possibility is to explore the tree of all games stochastically, an approach which al- lowed for instance to investigate the topological structure of the state space of chess [5]. A second option is to con- sider only opening sequences in the game tree. This al- lowed e.g. to identify Zipf's law in the tree of openings in chess [6] and in go [7]. A third possibility is to restrict oneself to local features of the game, by considering only local patterns. This approach was taken for instance in [8], where the frequency distribution of patterns in profes- sional go game records was investigated. Local patterns play an essential part in the most re- cent approaches to computer go simulators [9]. Pioneering software was based on deterministic algorithms [10, 11]. Today, computer algorithms implement Monte-Carlo go [12, 13] or Monte-Carlo tree search techniques [14 -- 17], which are based on a statistical approach : typically, the p-1 C. Coquid´e et al. value of each move is estimated by playing a game at ran- dom until its end and by assigning to the move the average winning probability. The random part relies on a playout policy which tells how to weight each probabilistic move. Such a playout policy rests on properties of local features, e.g. 3×3 patterns with atari status [18]. The most recent computer go approaches such as in AlphaGo [4], which fa- mously defeated a world champion in 2016 and 2017, also incorporates local pattern-based features such as 3×3 pat- terns and diamond-shaped patterns. In the present work, we investigate the differences be- tween human and computer players of go using statistical properties of complex networks built from local patterns of the game. We will consider networks whose nodes cor- respond to patterns describing the local situation on the 19 × 19 goban (board). In the original setting [19], we introduced a network based on 3 × 3 patterns of moves. We then extended it to larger, diamond-shaped patterns and explored the community structure of the network for human players [20]. Here we will focus on the differences between networks obtained from games played by humans and games played by computers. This study is new to the best of our knowledge. In a parallel way, there have already been previous studies to distinguish amateur and professional human players by looking at statistical dif- ferences between their games. For instance, professional moves in a fixed region of the goban were shown to be less predictable than amateur ones and this predictability turned out to evolve as a function of the degree of exper- tise of the professional [21]. Differences between amateur players of different levels were also identified in [20]. Here we will show that there are clear differences between com- plex networks based on human games and those based on computer games. These differences, which appear at a statistical level, can be seen as a signature of the nature of players involved in the game, and reveal the different processes and strategies at work. We will specify which quantities can be used to detect these differences, and how large a sample of games should be for them to be statis- tically significant. Additionnally, we will show that this technique allows to distinguish between computer games played with different types of algorithms. Construction of the networks. -- Our network de- scribing local moves in the game of go is constructed in the following way [19]. Nodes correspond to 3× 3 intersection patterns in the 19 × 19 goban with an empty intersection at its centre. Since an intersection can be empty, black or white, there are 38 such patterns. Taking into account the existence of borders and corners on the goban, and considering as identical the patterns equivalent under any symmetry of the square as well as colour swap, we end up with N = 1107 non-equivalent configurations, which are the nodes of our graph. Let i and j be two given nodes. In the course of a game, it may happen that some player plays at a position (a, b) which is the centre of the pattern la- beled by i, and that some player (possibly the same) plays later in the same game at some position (a(cid:48), b(cid:48)) which is the centre of the pattern labeled by j. If this happens in such a way that the distance between (a, b) and (a(cid:48), b(cid:48)) is smaller than some fixed distance ds, and that the move at (a(cid:48), b(cid:48)) is the first one to be played at a distance less than ds since (a, b) has been played, then we put a di- rected link between nodes i and j. Since part of the go game corresponds to local fights, the distance ds allows to connect moves that are most likely to be strategically related. Following [19] we choose this strategic distance to be ds = 4. We thus construct from a database a weighted directed network, where the weight is given by the number of occurences of the link in the games of the database. In what follows, we will use three databases. The first one corresponds to 8000 games played by amateur hu- mans, and is available online in sgf format [22]. The two other databases correspond to games played by com- puter programs, using either a deterministic approach or a Monte-Carlo approach. To our knowledge, there is no freely available database for computer games, and there- fore we opted for free go simulators. As a deterministic computer player we chose the software Gnugo [23]. Al- though this program is relatively weak compared to more recent computer programs, it is easy to handle and a seed taken as an input number in the program allows to de- terministically reproduce a game. Using 8000 different seeds and letting the program play against itself we con- structed a database of 8000 distinct computer-generated games. As a computer player implementing the Monte- Carlo approach we chose the software Fuego [24], plac- ing very well in computer go tournaments in the past few years, with which we generated a database of 8000 games. These databases allowed us to construct three distinct net- works, one from the human database and one for each computer-generated one. In order to investigate the role of the database size, we also consider graphs constructed from smaller subsets of these databases (with networks constructed from 1000 to 8000 games). General structure of the networks. -- We first in- vestigate the general structure of the three networks built from all 8000 games for each database. Taking into ac- count the degeneracies of the links, each node has a total of Kin incoming links and Kout outgoing links. The (normal- ized) integrated distribution of Kin and Kout, displayed in Fig. 1 for each network, shows that general features are similar. In all cases, the distribution of outgoing links is very similar to the distribution of ingoing links. This symmetry is due to the fact that the way of construct- ing the networks from sequentially played games ensures that in most cases an ingoing link is followed by an outgo- ing link to the next move. The distributions of links are close to power-law distributions, with a decrease in 1/K γ with γ ≈ 1.0. Networks displaying such a power-law scal- ing of the degree distribution have been called scale-free networks [25]. Many real-world networks (from ecological webs to social networks) possess this property, with an p-2 Distinguishing human and computers in the game of go the database. The PageRank vector, that will be defined below, allows to take into account the network structure in order to rank all nodes according to their significance within the network. It allows to go beyond the mere fre- quency ranking of the nodes, where nodes would be or- dered by the frequency of their occurence in the database. Physically speaking, the significance of a node is deter- mined by the average time that would be spent on it by a random walker moving on the network by one step per time unit and choosing a neighouring node at random with a probability proportional to the number of links to this neighbour. Such a walker would play a virtual game where, at each step, it can play any move authorized by the network, with some probability given by the network. The PageRank vector assigns to any node i a nonnega- tive value corresponding to the equilibrium probability of finding this virtual player on node i. More precisely, the PageRank vector is obtained from the Google matrix G, defined as Gij = αSij + (1 − α)/N , with S the matrix obtained by normalizing the weighted adjacency matrix so that each column sums up to 1 (any column of 0 being replaced by a column of 1/N ), and α is some parameter in [0, 1]. Since G is a stochastic matrix (all its columns sum up to 1), there is a vector p such that Gp = p and pi ≥ 0 for 1 ≤ i ≤ N . This right eigen- vector of G, associated with the eigenvalue 1, is called the PageRank vector. We can then define the correspond- ing ranking vector (ak)1≤k≤N , with 1 ≤ ak ≤ N , as the permutation of integers from 1 to N obtained by ranking nodes in decreasing order according to the entries pi of the PageRank vector, namely pa1 ≥ pa2 ≥ . . . ≥ paN . As an illustration, we show in Fig. 2, for each network, the 20 nodes a1, . . . , a20 with largest PageRank vector entry pi. The distinction clearly appears. For instance, among the 20 entries of the human network only 12 appear in the Gnugo Pagerank vector (18 in the Fuego one). In order to quantify more accurately the discrepancy between the human and computer PageRank vectors, and between PageRank vectors obtained for different database sizes, we consider the correlations between their associated ranking vectors. If p and q are two PageRank vectors, let A = (ak)1≤k≤N and B = (bk)1≤k≤N be their respective ranking vectors, with 1 ≤ ak, bk ≤ N . The correlations are estimated from the discrepancy between pairs (ak, bk) and the line y = x. As an illustration, such correlation plots are shown in Fig. 3, where pairs (ak, bk) are plotted for the Gnugo and human databases. While correlation be- tween two human PageRanks or two Gnugo PageRanks is quite good, the correlation between human and computer- generated networks is very poor. This observation does not depend on the choice or the size of the database: in- deed, as appears in Fig. 3, several different databases of different sizes all give comparable results. In order to be more quantitative, we introduce the dispersion (cid:33)1/2 (cid:32)(cid:80)(cid:98)N/2(cid:99) k=1 (ak − bk)2 (cid:98)N/2(cid:99) σ(A, B) = , (1) Fig. 1: Integrated distribution of ingoing links K∗ in = Kin/ktot and outgoing links K∗ out = Kout/ktot. Here ktot is the total number of links in the network (from top to bottom 1589729, 2046260 and 1527421). P (K∗) is defined as the proportion of nodes having more than K = ktotK∗ links. From top to bot- tom, deterministic computer (Gnugo, empty blue K∗ in, filled maroon K∗ out), Monte-Carlo computer (Fuego, empty orange K∗ in, filled grey K∗ in, filled black out), shifted down by respectively 0, −1/2 and −1 for clar- K∗ ity. The leftmost point corresponds to the nodes with minimal number of links kmin (here kmin = 1 or 2), with abscissa kmin/ktot and ordinate 1 − N0/N , N0 being the number of out) and humans (empty red K∗ nodes with no link. The righmost point corresponds to the node with maximal number of links kmax (which happens to be also the node with highest PageRank shown in Fig. 2), with abscissa kmax/ktot and ordinate 1/N . The networks are all built from 8000 games. Black dashed lines have slope −1. exponent γ typically around 1 (see Table II of [26]). Our networks belong to this class, which indicates the pres- ence of hubs (patterns with large numbers of incoming or outgoing links), and more generally a hierarchical struc- ture between patterns appearing very commonly and oth- ers which are scarce in the database. While the distributions for the three networks are very similar, the power-law scaling ends (on the right of the plot) at a smaller value of K in the case of both com- puter go networks, with strong oscillations. The right- most points correspond to hubs. The figure shows that such hubs are slightly rarer in the computer case than in the human one. This may indicate that certain moves are preferred by some human players independently of the global strategy, while computers play in a more even fash- ion. However, at the level of these distributions the differ- ences between databases seem too weak to lead to reliable indicators. PageRank. -- Each directed network constructed above can be described by its N × N weighted adjacency matrix (Aij)1≤i,j≤N , with N = 1107, such that Aij is the number of directed links between i and j as encountered in p-3 -7-6-5-4-3-2-10log10(K*in,out)-4-3-2-10log10(P(K*in,out)) C. Coquid´e et al. Fig. 2: First 20 patterns as ranked by the PageRank vector, for the networks generated by Gnugo (top), Fuego (middle) and humans (bottom), each built from 8000 games, for α = 0.85 (see text). Black plays at the cross. ized by(cid:80) where we restrict ourselves to the first half of the entries, corresponding to the largest values of the pi (this trun- cation to N/2 amounts to neglecting entries smaller than pa554, which, for all samples and database sizes investi- gated, is of order (cid:39) 3.10−4 for a PageRank vector normal- i pi = 1). The dispersion gives the (quadratic) mean distance from perfect correlation function y = x to points (ak, bk) in the plot of Fig. 3, with for ran- dom permutations σ ≈ 450 on average. In the case of two groups of 4000 games, the human-human dispersion is 43.66, the computer-computer one is 24.04, while the human-computer one is 192.58. A similar discrepancy can be measured for the 1000 game groups, with a dispersion σ (averaged over the different samples) given by σ = 66.71 for human-human , σ = 44.14 for computer-computer, and σ = 199.27 for human-computer. The plot at the bottom of Fig. 3 is a PageRank correlation plot between human and computer with the whole database of 8000 games for each, giving σ = 193.48. Spectrum of the Google matrix. -- The PageR- ank vector is the right eigenvector of G associated with the largest eigenvalue λ = 1. It already shows some clear differences between the networks built by computer-played games and human-played games. We now turn to subse- quent eigenvalues and eigenvectors. In Fig. 4 we display the distribution of eigenvalues of the Google matrix in the complex plane for the three networks of 8000 games. Properties of the matrix impose that all eigenvalues lie inside the unit disk, with one of them (associated with the PageRank) exactly at 1, and that complex eigenval- ues occur in conjugated pairs. The spectra obtained from Fig. 3: PageRank-PageRank correlation for networks built from subsets of the database of computer (Gnugo) or human games (α = 0.85). First line: databases are split into 2 groups of 4000 games, yielding two distinct networks, and correlator between the two PageRanks is plotted. Second line: database is split into 8 groups of 1000, and 4 correlators are plotted: group 1 vs 2 (black) 3 vs 4 (red), 5 vs 6 (green), 7 vs 8 (blue). Middle column corresponds to human vs computer, left column to human vs human, right column to computer vs computer. Bottom panel: Same for networks constructed from the whole database (8000 human vs 8000 computer games). Nodes are ranked according to the PageRank of each network. Only the (cid:98)N/2(cid:99) = 553 first nodes are plotted. different networks are clearly very different: eigenvalues for the network built from computer-played games using Gnugo are much less concentrated around zero, with many eigenvalues at a distance 0.2-0.6 from zero which are ab- sent in the other networks. Moreover, while the bulk of eigenvalues looks similar for games played by Fuego or by humans, many outlying eigenvalues are present in the case of Fuego. To make these observations more quantita- tive, we plot in the main panel of Fig. 4 the radius λc(x) of the minimal circle centred at 0 and containing a cer- tain percentage x of eigenvalues. The difference between the two behaviours is striking. Considering plots obtained from subsets of the databases, we see that the result is robust: although λc(x) depends much more on the size of the subset used to build the network for Gnugo than for the other two networks, the difference between the plots remains clear. In fact, the presence of eigenvalues with large absolute value has been related to the existence of parts of the net- work which are weakly linked to the rest ('communities'). Eigenvalues lying out of the bulk in the Fuego network would mean that there are more communities present in that network than in the human case, and even more in p-4 0500human0500computer0500computer0500human0500human0500computer0500computer0500computer0500human0500computer Distinguishing human and computers in the game of go where ∗ denotes complex conjugation. The fidelity is F = 1 for two identical vectors, and F = 0 for orthogonal ones. In Fig. 5 (top panel) we plot the fidelity of the 7 right eigenvectors of G corresponding to the largest eigen- values 1 = λ1 > λ2 ≥ λ3 ≥ . . . ≥ λ7. It shows that the fidelity decreases much faster in the computer/human comparison than in both the cases of subgroups of hu- man/human and computer/computer, where it remains very close to 1 for the first 4 eigenvectors, indicating that, remarkably, these eigenvectors only weakly depend on the choice of the data set but strongly on the nature of the players. Interestingly enough, in the computer/computer case there is also a dropoff starting from the fifth eigen- vector. This may be due to inversion of close eigenvalues between two realizations of the subgroups. In order to compare more accurately the eigenvectors at the level of patterns, one can define quantities based on ranking vectors, in line with the ranking of nodes that can be obtained from the PageRank vector. For any eigen- vector, we define a ranking vector A = (ai)1≤i≤N with 1 ≤ ai ≤ N , where nodes are ordered by decreasing values of the modulus of the components of the vector. We thus define the Ordered Vector Similarity SO, which takes the value 1 if two ranking vectors are identical in their first 30 entries (this choice of cut-off is arbitrary but keeps only the most important nodes). Namely, if A = (ai)1≤i≤N and B = (bi)1≤i≤N are two ranking vectors, SO is defined through SO(A, B) = f (i) 30 , f (i) = if ai = bi otherwise. (3) (cid:26) 1 0 30(cid:88) i=1 The similarity SO gives the proportion of moves which are exactly at the same rank in both ranking vectors within the first 30 entries. This quantity is shown in Fig. 5 (mid- dle panel). Again the data single out the computer/human similarity as being the weakest. However, the choice of the data set affects the results: the dependence on the number of games used to build the networks inside each database is relatively large, and makes the results less statistically significant than for the fidelity. This is due to the fact that some components of the vectors can have very similar val- ues, and a small perturbation can then shuffle the ranking of components. To make this effect less important, we de- fine a Non-ordered Vector Similarity SN for two vectors A and B through a new similarity function fbis: fbis(i) = if ∃ j ∈ [1; 30] such that ai = bj, otherwise. (cid:26) 1 0 SN is thus defined as: SN (A, B) = 30(cid:88) i=1 fbis(i) 30 (4) (5) Fig. 4: Top row : spectrum of the Google matrix for α = 1 (see text) for the network generated by computers (Gnugo left, Fuego middle) and humans (right). Main plot : λc(x) for x = 50, 60, 70, 80, 90 (see text), for Gnugo (blue circles), Fuego (orange squares) and humans (red diamonds), averaged over m networks built from 1000 games (m = 8, dashed line), 4000 games (m = 2, long dashed line) and 8000 games (m = 1, full line). the Gnugo network. Note however that the average num- ber of moves per game is larger for Fuego, which reflects in the total number of links in the network (see caption of Fig. 1), and may give a small bias in the comparison. The outlying eigenvalues seem to indicate that the determinis- tic program, and less markedly the Monte-Carlo one, can create different groups of moves linked to each other and not much linked to the other moves, i.e. different strate- gies relatively independent from each other. This can be related with the results displayed in Fig. 1, which show the presence of more hubs with large number of links in the network generated by human-played games. Other eigenvectors of the Google matrix. -- The analysis of the PageRank vector, which is the eigenvec- tor associated with the largest eigenvalue, has shown (see Fig. 2) that the most significant moves differ between the three networks. When eigenvalues are ordered according to their modulus, as 1 = λ1 > λ2 ≥ λ3 . . ., the right eigenvectors associated with eigenvalues λ2, λ3, . . . may be expected to display more refined differences between the networks. In order to quantify the difference between eigenvectors of the Google matrix, we consider two vec- tors φ and ψ of components respectively φi and ψi, nor- i ψi2 = 1, and we introduce (following the usual definition from quantum mechanics) the fidelity malized in such a way that (cid:80) F = N(cid:88) i φi2 =(cid:80) i ψi, φ∗ i=1 In this quantity, what matters is now the proportion of moves which are common to both lists of the 30 most im- portant moves, irrespective of their exact rankings through (2) p-5 5060708090x (% of eigenvalue ≤ λc)00.10.20.30.4λc(x)-0.500.51Re(λ)-0.500.5Im(λ)-0.500.51Re(λ)-0.500.51Re(λ) C. Coquid´e et al. Towards a Turing test for go simulators. -- Fig- ures 1 -- 5 illustrate the differences between networks built from computer-played games and the ones built from human-played games. These differences are relatively dif- ficult to characterize at the level of the distributions of links of Fig. 1. On the other hand, Figs. 3 and 5 show that the eigenvectors associated with largest eigenvalues allow more clearly to distinguish between the types of players, with statistical differences visibly stronger than the ones between the networks built from different subgroups of the same database. This indicates that it may be possible to conceive an indicator to differentiate between a group of human-played games and computer-played games, with- out any previous knowledge of the players. This could be similar to the famous Turing test of Artificial Intelligence, where a person tries to differentiate a human from a com- puter from answers to questions, without prior knowledge of which interlocutor is human. In our case, confronted with databases of games from both types of players, it could be possible to differentiate the human from the com- puter from statistical tests on the network. To construct such an indicator, we focus on the PageRank which corre- sponds to the largest eigenvalue of the Google matrix, and use the three quantities which distinguish best the differ- ent types of players, namely the fidelity F , Non-ordered Vector Similarity SN and dispersion σ. The first two quan- tities describe discrepancies mostly for the largest values of the PageRank, while the dispersion is dominated by in- termediate values (see Fig. 3). In order to synthetize the results from these two kinds of quantities, we present in Fig. 6 the pairs (F, σ) and the pairs (SN , σ) for PageR- ank vectors constructed from games played by humans or computers. The data displayed in Fig. 6 show that there is some variability of these quantities if subgroups from the same databases are compared, indicated by the error bars. How- ever, the difference between the computer- and human- generated networks is much larger than this variability, indicating that there is a statistically significant difference between them. Interestingly enough, it is also possible to distinguish between the different types of algorithms used in the computer games: differences between Fuego and Gnugo are larger than the variability when compared to humans, and also when compared to each other. We have included the result obtained for games played by AlphaGo, based on the small 50-game database available [27]; de- spite the smallness of the database, the points obtained seem to be also statistically well separated from humans. Conclusion. -- Our results show that the networks built from computer-played games and human-played games have statistically significant differences in several respects, in the spectra of the Google matrix, the PageR- ank vector or the first eigenvectors of the matrix. There are also differences between the different types of algo- rithms which can be detected statistically, from determin- istic to Monte Carlo and even (although the database is Fig. 5: Top: Fidelity (2) for the 7 first right eigenvectors (corre- sponding to the largest eigenvalues of G, including the PageR- ank, for α = 0.85), for computer (Gnugo) and human networks, in decreasing order of the norm of the associated eigenvalue, for human-human (red diamonds), computer-computer (blue circles), computer-human (green triangles). Each point is an average over NS different choices of pairs of groups. Networks are built from groups of 4000 games (solid line, NS = 30), 2000 games (dashed line, NS = 180) and 1000 games (dotted lines, NS = 840) (for computer/human resp. NS = 120, 480, 1920). Standard deviation is comparable to symbol size for the 3 first eigenvectors, and is much larger for subsequent ones. Middle and bottom: Ordered Vector Similarity (3) and Non-ordered Vector Similarity (5) respectively for the 7 first eigenvectors, same conventions and datasets as above. both vectors. The data are displayed for this quantity on Fig. 5 (bottom panel). The dispersion between different choices of subgroup sizes in the same database is now much more reduced, and the results from the human vs com- puter case are now clearly separated from the ones inside one of the individual databases. p-6 Label of righteigenvector Distinguishing human and computers in the game of go ∗ ∗ ∗ We thank Vivek Kandiah for help with the computer programming and scientific discussions. We thank Calcul en Midi-Pyr´en´ees (CalMiP) for access to its supercomput- ers. OG thanks the LPT Toulouse for hospitality. REFERENCES [1] Helander M. G., Handbook of human-computer interac- tion 2014 (Elsevier, North Holland) [2] Tromp J. and Farneback G., Combinatorics of Go, Proc. of the 5th Int. Conf. on Computer and Games, edited by Van den Herik H. J., Ciancarini P. and Donkers H. H. L. M. Lect. Notes in Comp. Sciences, 4630 (2007) 72 [3] Walraet M. and Tromp J., Computers and Games. Springer International Publishing, edited by Plaat A., Kosters W., van den Herik J. 2016, p. 191 [4] Silver D. et al., Nature, 529 (2016) 484 [5] Atashpendar A., Schilling T. and Voigtmann T., Eu- rophys. Lett., 116 (2016) 10009 [6] Blasius B. and Tonjes R., Phys. Rev. Lett., 103 (2009) 218701 [7] Xu L.-G., Li M.-X. and Zhou W.-X., Europhys. Lett., 110 (2015) 58004 [8] Liu Z., Dou Q. and Lu B., Lect. Notes in Comp. Sciences, 5131 (2008) 125 [9] Stern D., Herbrich R. and Graepel T., Proc. of the 23rd int. conf. on Machine learning 2006, p. 873 [10] Schraudolph N. N., Dayan P. and Sejnowski T. J., Adv. in Neural Inf. Processing, 6 (1994) 817; Chen K. and Chen Z., Inf. Sciences, 121 (1999) 113 [11] Bouzy B. and Cazenave T., Art. Int., 132 (2001) 39 [12] Chaslot G. et al., Proc. of the 18th BeNeLux Conf. on Artificial Intelligence, edited by Schobbens P. Y., Van- hoof W. and Schwanen G. 2006, p. 83 [13] Wang Y. and Gelly S., IEEE Symposium on Compu- tational Intelligence and Games (CIG 2007) 2007, p. 175 [14] Chaslot G. et al., New Mathematics and Natural Com- putation, 4 (2008) 343 [15] Browne C. B. et al., IEEE Transactions on Computa- tional Intelligence and AI in Games, 4 (2012) 1 [16] Coulom R., Proc. of the 5th Int. Conf. on Computer and Games, edited by van den Herik H. J. , Ciancarini P. , and Donkers H. H. L. M. Lect. Notes in Comp. Sciences, 4630 (2007) 72 [17] Gelly S. et al., Comm. of the ACM, 55 (2012) 106 [18] Huang S.-C., Coulom R. and Lin S.-S., Lect. Notes in Comp. Science, 6515 (2011) 81 [19] Georgeot B. and Giraud O., Europhys. Lett., 97 (2012) 68002 [20] Kandiah V., Georgeot B. and Giraud O., Eur. Phys. J. B, 87 (2014) 246 [21] Harr´e M. S. et al., Eur. Phys. J. B, 80 (2011) 555 [22] http://www.u-go.net/ [23] http://www.gnu.org/software/gnugo/ [24] http://fuego.sourceforge.net/ [25] Barab´asi A.-L. and Albert R., Science, 286 (1999) 509 [26] Albert R. and Barab´asi A.-L., Rev. Mod. Phys., 74 (2002) 47 [27] http://senseis.xmp.net/?AlphaGo Fig. 6: Fidelity (2) (top) and Non-ordered Vector Similarity (5) (bottom) of pairs of PageRanks as a function of the dispersion σ of (1), for databases of human players and three computer programs: Gnugo, Fuego and AlphaGo. We use α = 0.85. For each case, one PageRank corresponds to a 8000-game net- work, and the other one to several choices of networks built from smaller samples; empty symbols correspond to averages over 1000-game networks, checkerboard ones to 2000-game net- works, filled ones to 4000-game networks. Averages are made respectively over 240 instances, 120 instances, 60 instances. Error bars are standard deviations of these averages. For Al- phaGo, a 50-game network was used. smaller) the recent AlphaGo. In general, the computer has a tendency to play using a more varied set of most played moves, but with more correlations between differ- ent games for the deterministic program (Gnugo) and less for the stochastic one (Fuego). These statistical differences could be used to devise a Turing test for the go simulators, enabling to differenti- ate between the human and the computer player. Inter- estingly enough, it does not seem to require very large databases to reach statistical significance. We note that a manifestation of these differences was noted during the games played by AlphaGo against world champions in 2016 and 2017: the computer program used very surpris- ing strategies that were difficult to understand by human analysts following the games. The results shown in this study show that the computer programs simulating complex human activities proceed in a different way than human beings, with characteristics which can be detected with statistical significance using the tools of network theory. It would be very interesting to probe other complex human activities with these tools, to specify if the differences between human and comput- ers can be quantified statistically, and to deduce from it the fundamental differences between human information processing and computer programming. p-7 0,751FComputer (Gnugo) / Computer (Gnugo)Computer (Fuego) / Computer (Fuego)Human / HumanComputer (Gnugo) / HumanComputer (Fuego) / HumanComputer (Alphago) / HumanComputer (Fuego) / Computer (Gnugo)050100150200250300σ0,50,751SN
1911.05484
1
1911
2019-10-26T12:21:58
Extracting a Discriminative Structural Sub-Network for ASD Screening using the Evolutionary Algorithm
[ "cs.SI", "cs.LG", "cs.NE" ]
Autism spectrum disorder (ASD) is one of the most significant neurological disorders that disrupt a person's social communication skills. The progression and development of neuroimaging technologies has made structural network construction of brain regions possible. In this paper, after finding the discriminative sub-network using the evolutionary algorithm, the simple features of the sub-network lead us to diagnose autism in various subjects with plausible accuracy (76% on average). This method yields substantially better results compared to previous researches. Thus, this method may be used as an accurate assistance in autism screening
cs.SI
cs
Extracting a Discriminative Structural Sub-Network for ASD Screening using the Evolutionary Algorithm M. Amin, F. Safaei, N. S. Ghaderian Faculty of Computer Science and Engineering, Shahid Beheshti University G.C., Evin 1983963113, Tehran, IRAN [email protected], [email protected], [email protected] Abstract Autism spectrum disorder (ASD) is one of the most significant neurological disorders that disrupt a person's social communication skills. The progression and development of neuroimaging technologies has made structural network construction of brain regions possible. In this paper, after finding the discriminative sub-network using the evolutionary algorithm, the simple features of the sub-network lead us to diagnose autism in various subjects with plausible accuracy (76% on average). This method yields substantially better results compared to previous researches. Thus, this method may be used as an accurate assistance in autism screening. Keywords: Autism spectrum disorder- structural brain networks-sub-network- evolutionary algorithm 1. Introduction Neurological diseases are either biochemical or electrical based and they cause specific symptoms in the patient. Alzheimer, Parkinson, Multiple Sclerosis, Autism Spectrum Disorder (ASD) are the most important examples of neurological diseases [5]. Autism spectrum disorder (ASD) is one of the most significant neurological disorders that disrupts a person's social communication skills. The progression and development of neuroimaging technologies and modeling the connections between various brain regions using graphs, has led to screening these disorders with higher speed and accuracy. Complex networks consist of nodes that are related to each other and have specific features that differentiates them from random networks. The reason for this complexity is that the behavior of the network cannot be derived from the behavior of a specific nodes. The internet, social networks, neural or brain region networks, the relation between proteins, airlines, VLSI circuits etc. are just a few examples of complex networks. According to recent studies, the brain is a modular network that follows the features of the small-world [1]. Using neuroimaging technologies and methods it is possible to derive functional and structural networks of the brain. DTI is a neuroimaging technique based on MRI that allows us to estimate the position, direction and anisotropy of the brain's white matter tracts. Structural brain networks are made using image processing done on DTI that more details are discussed in [1]. In structural brain networks the nodes are usually brain regions and the weight of the edges are the number of fibers between these regions. 1 Various studies have been conducted on structural brain networks and many of them are focused on the classification of these networks; for example the classification of these networks into two classes of healthy control and Autism spectrum disorder. The classification of complex networks has many usages i.e. time series anomaly detection [2], link prediction [2,3], cancer cells detection [4], recognition of type of proteins [4], classification in graph based search engines [4], modeling large networks [4], comparing social networks [5], diagnosing neurological disorders [5] etc. There have been many proposed classification methods for networks that mainly fall into either one of two categories, kernel based or feature based [2, 4, 6-8]. Kernel based methods are very slow because of algorithm complexity [2, 9]. Most previous studies on network classification have used complete networks for their classification. There are logical reasons to choose sub-networks to classify instead of complete networks. A number of them are as follows: 1. When using complete network we usually use the edges as features that causes over-fit because of too many features and too little scans. 2. Specific sub-networks of the brain can give us more info on different disorders and lower the risk of neutralizing the features of a disorder via some nodes. 3. Processing speed increases faster while processing sub-networks. 4. Better interpretation can be achieved when we have a discriminative sub-network. The aforementioned sub-networks are not specific regions in regards to functionality or structure, but a subdivision of nodes and edges that have been chosen from the main network [10]. In this study, a method has been proposed that uses an evolutionary algorithm to find the discriminative sub-network in the classification, and by utilizing theory of graph, metrics extracts and completes the classification. The chosen sub-network has fewer edges and nodes than the complete network and this sub-network has gained high scores in evolutionary algorithm evaluation thus, the classification is completed faster and more accurately than previous research studies. In Section 2 previous studies are described and in Section 3, the proposed method has been explained. In Section 4 the results of the simulation and in Section 5 the results of the study and future work are demonstrated. 2. Related Literature There have been many studies conducted on neurocognitive disorders. With the development of technology and machine learning and deep learning methods, researchers are aiming towards feature-based methods. The basis of these methods is the extraction of structural brain features and utilizing machine learning models to diagnose disorders. Basset and Sporns [11] were the first to suggest neurological networking. They showed that in the era of big data, neurology needs statistical inference and other theoretical ideas to be able to search the structure and functionality of the brain. Crossly et al. [12] showed that the placement of hubs can change parallel to each other at high rates and this change can transform the type and steps of cognitive processing. Dennis and Thompson [13] studied the possibility that dementia can be slowed down or stopped and tried to derive the first symptoms of Alzheimer using a brain network. Rubinov and Sporns [14] presented a group of local and global features for brain networks that can be used to train a machine learning model. Dodero et al. [15] attempted to classify brain networks using kernel based methods. 2 Tolan and Isik [5] proposed a binary classification model that differentiates between a person with autism and a person with healthy controls. They calculated the local and global features of the structural and functional brain networks and used this feature vector to train different machine learning models. In order to aggregate the local features they used minimum, maximum, standard deviation and etc methods. In addition to these features, the gender of each person is also considered as an item in the feature vector. They used the relief method [17] in order to decrease the feature vector dimensions and choose the best features. To calculate feature values, they utilized BRAPH tools [16]. They used the LOOCV method as an evaluation strategy and apply their method on the data in [18] for training and testing machine learning models. Petrov et al. [19] proposed a method that can differentiate between a healthy control and autism brain. They used 16 features that are proportionate to the value of the edges and network topology features. Eventually, they utilized the SVM model for classification. For choosing efficient sub-networks for classification, Brown et al. [10] proposed an efficient method. They presented an optimization problem that specifies which nodes and edges to keep and which ones to put aside. The aforementioned methods have disadvantages; the first and foremost being the low accuracy. Kernel-based and some feature-based methods are also slow. The proposed method in this paper has higher accuracy and speed when compared to previous methods as instead of processing the whole network; it only processes the discriminative sub- network. Feature Extraction Figure 1. Illustration the proposed method. The structural brain sub-network was derived after the evolutionary algorithm was run, and was used for classification. In this paper, for the first time, a method has been proposed comprehensively that uses the evolutionary algorithm to choose an effective sub-network and using network topology features, classification is done with sufficient speed and accuracy. In the following section, the proposed method is extensively described. 3. The Proposed Method With the vast development of neuroimaging technology, deriving the functional and structural networks of different brain regions has been made possible. In this article, a novel method has been proposed that uses the evolutionary algorithm to find an efficient discriminative sub-network, and classify the networks into two groups of healthy 3 control and autism spectrum disorder via extracting the topology features. In this article, the dataset in [18] has been used. The information is presented in table 1. Table 1. Dataset Information HC 42 ASD 51 Total 93 For implementing the proposed method, the programming language python version 2.7, the complex network library NetworkX version 2.1, the machine learning library scikit-learn version 1.0.9.2 and the editor PyCharm 2018 version were utilized. The main process of the proposed method can be seen in Figure 1. The first step is to find the discriminative sub- network; a sub-network in which the metrics calculated have a greater differentiation between the healthy control and autism spectrum disorder groups and thus, classification is more accurate. Each structural network of the dataset has 264 nodes (each node is a region of the brain) therefore, each node has a label with a value between 0 and 255. Assume a string of length 264 in which each unit can be zero or one. The position of each unit corresponds to the label of each node. If the unit in that position is one, the node exists in the network. If the unit is zero, the node doesn't exist in the network (and neither does the edges leading up to the node.). In the case that all units in the string are one, all nodes exist thus the network is complete. 3.1 Evolutionary Algorithm Our problem is finding the sub-network that yields a higher level of differentiation between the network topology metrics of the healthy control and autism groups. As a result, this sub-network also yields a more accurate classification. According to the number of nodes, if all possible states are examined, there would be 2264-2 states to examine. Therefore, evolutionary algorithms are used to find the discriminative sub-network. Presentation method One of the important beginning steps for using evolutionary algorithms is finding a suitable presentation method for the solutions. Choosing the suitable presentation method facilitates the process of mapping the genotypes to the phenotypes. As mentioned before, the presentation method for the solutions is in binary. Initial Population For launching the evolutionary algorithm, an initial population is essential. The population must have a high diversity and the number of people in the population must be suitable. If not, the algorithm's execution speed will decrease. There are two methods to choose an initial population, random population and heuristic population. In this article, random population is used. The initial population has 80 solutions that have been picked at random. Fitness function To calculate the fitness of each solution, the threshold is applied to each network. Then, the nodes (and edges connected to them) corresponding to the zero units in the solution are deleted. Thereupon, using the features described in the following paragraphs, a decision tree is trained. Finally, evaluation is done via the LOOCV evaluation method. The average classification accuracy is the value of the solution fitness. Selection The best solution of a generation is selected via the truncated based selection method. This method sorts the solutions based on fitness and selects p percent of them. Thereupon, each selected solution is reproduced 1/p times. 4 Cross-over The cross-over operator is similar to biological rebirth and synthesis. There are various synthesis methods. In this paper, the one point cross-over method is used in which two solutions are selected first then, a point between 1 and the length of the solution is randomly chosen. Finally, the two parts, before and after the chosen point are switched. Stop Condition Choosing a rational ending condition is essential. If not chosen, the algorithm will never end. In this study, there are two stop conditions. Whichever one is reached, the algorithm stops. The first one is the number of generations constraint and the other is reaching the desired accuracy limit. 3.2 Features Selection for Classification For each network, a specific edge weight threshold must be applied first. This threshold has been chosen according to [1]. The threshold for each network is a value with which the network sparseness value becomes 0.025. This value is demonstrated by S(G) for network G with edge set E, and node set V . S(G) is expressed by the following equation. (1) In which, n is the number of nodes in the network. The specified features for each network are categorized as two groups, local and global. The global network features for network with an edge set E, and a node set V are as follows. 1. The transitivity feature that is expressed as follows In which ltr is the number of all possible triangles in network G and lt is the number of network triads. 2. The average clustering feature that is given by In which Ci is the node clustering coefficient and n is the number of nodes in the network. 3. The global efficiency feature that is calculated as 5 (2) (3) (4) 2()(1)ESGnn3()ltrTGlt11()niiCGCn,11()1jVjiijiVdEGnn In which, dij is the shortest route between two nodes, i and j. Moreover, n is the number of nodes in the network. Local features are also determined for each node. The following included: 1. The closeness feature that is calculated as (5) In which d(u,v) is the shortest route between nodes u and v; n is the number of nodes in the network. 2. The betweenness feature that is determined by the following equation (6) In which is the number of short routes between and , and is the number of routes that include node v. 3. The triangle feature that derives the number of triangles for node v that include itself. For the local features, three aggregation methods (maximum, average and standard deviation) are used. Therefore, there are 12 features for each network. Figure 2. The mean accuracy comparison between the proposed method and the related work 6 111()(,)nvnCCGduv,(,)()(,)stVstvBCGst(,)st(,)stv0.580.60.620.640.660.680.70.720.740.760.78Petrov et al. [19]Dodero et al.[15]Tolan and Isik[5]The proposedmethodMethodsAccuracy Healthy Control Autism Dysfunction Accuracy Macro Average Weighted Average Healthy Control Autism Dysfunction Accuracy Macro Average Weighted Average Table 2. LOOCV Evaluation Report Discriminative sub-network precision 0.74 0.77 - 0.76 0.76 Complete network precision 0.37 0.47 - 0.42 0.42 Recall 0.71 0.80 - 0.76 0.76 recall 0.44 0.39 - 0.42 0.41 f1-score 0.72 0.79 0.76 0.76 0.76 f1-score 0.40 0.43 0.41 0.41 0.41 4. Simulation Results In the previous section, we discussed the method proposed in order to find the discriminative sub-network using the evolutionary algorithm. The derived sub-network has 127 nodes. From here the sub-network may be used instead of the complete network for classification. The evaluation of choosing a sub-network and its effect on classification accuracy was done via the LOOCV method. This procedure was done 100 times using the extracted sub-network. The results have been reported in Table 2. The 12 features mentioned were used in training the decision tree. As depicted in table 2, the important sub- network is effective and the recall, precision and accuracy are much higher than that of a complete network. Many researchers have studied structural brain networks and various methods of classification into the two groups of healthy control and autism have been proposed and implemented, Figure 2 shows the accuracy comparison between these methods and the one proposed in this paper. 5. Conclusions Autism spectrum disorder (ASD) is one of the most significant neurological disorders that disrupts a person's social communication skills. Developing new screening methods using structural and functional brain networks is valuable as diagnosing autism with plausible accuracy at a young age, while symptoms are not yet visible, can be beneficial to the patient. In this paper it is assumed that instead of processing the whole brain structural network, it is possible to find a sub-network which depicts the difference between the structural network of a healthy brain and a brain with autism more clearly. The sub-network extraction (instead of whole brain network) must also increase the speed and accuracy of classification. In future studies, more features may be used, various models of machine learning can be experimented and other types of evolutionary algorithms can be used. References [1] [2] [3] J. D. Rudie et al., "Altered functional and structural brain network organization in autism," NeuroImage: Clinical, vol. 2, pp. 79-94, 2013. S. Bonner, J. Brennan, G. Theodoropoulos, I. Kureshi, and A. S. McGough, "Deep topology classification: A new approach for massive graph classification," in 2016 IEEE International Conference on Big Data (Big Data), 2016. A. Pecli, M. C. Cavalcanti, and R. Goldschmidt, "Automatic feature selection for supervised learning in link prediction applications: a comparative study," Knowledge and Information Systems, vol. 56, no. 1, pp. 85-121, Oct. 2017. 7 [4] [5] [6] [7] [8] [9] JP.Canning, EE.Ingram, SN.Wolff, AM.Ortiz, NK.Ahmed, RA.Rossi, KRB.Schemitt, S. Soundarajan," Predicting Graph Categories from Structural Properties,"CoRR,vol. abs/1805.02682, 2018. E. Tolan and Z. Isik, "Graph Theory Based Classification of Brain Connectivity Network for Autism Spectrum Disorder," in Bioinformatics and Biomedical Engineering, Springer International Publishing, 2018, pp. 520-530. S.Bonner, J.Brennan, G. Theodoropoulos, I. Kureshi and AS.McGough," Efficient Comparison of Massive Graphs Through The Use Of 'Graph Fingerprints,' "Twelfth Workshop on Mining and Learning with Graphs (MLG) '16 San Francisco, California USA, 2016. B. Kantarci and V. Labatut, "Classification of Complex Networks Based on Topological Properties," in 2013 International Conference on Cloud and Green Computing, 2013. A. Grover and J. Leskovec, "node2vec," in Proceedings of the 22nd ACM SIGKDD International Conference on Knowledge Discovery and Data Mining-KDD '16, 2016. N. S. Ketkar, L. B. Holder, and D. J. Cook, "Empirical comparison of graph classification algorithms," in 2009 IEEE Symposium on Computational Intelligence and Data Mining, 2009. [10] C. J. Brown, S. P. Miller, B. G. Booth, J. G. Zwicker, R. E. Grunau, A. R. Synnes, V. Chau, and G. Hamarneh, "Predictive connectome subnetwork extraction with anatomical and connectivity priors," Computerized Medical Imaging and Graphics, vol. 71, pp. 67 -- 78, Jan. 2019. [11] D. S. Bassett and O. Sporns, "Network neuroscience," Nature Neuroscience, vol. 20, no. 3, pp. 353-364, Mar. 2017. [12] N. A. Crossley et al., "Cognitive relevance of the community structure of the human brain functional coactivation network," Proceedings of the National Academy of Sciences, vol. 110, no. 28, pp. 11583- 11588, Jun. 2013. [13] E. L. Dennis and P. M. Thompson, "Functional Brain Connectivity Using fMRI in Aging and Alzheimer's Disease," Neuropsychology Review, vol. 24, no. 1, pp. 49-62, Feb. 2014. [14] M. Rubinov and O. Sporns, "Complex network measures of brain connectivity: Uses and interpretations," NeuroImage, vol. 52, no. 3, pp. 1059 -- 1069, Sep. 2010. [15] L. Dodero, H. Q. Minh, M. S. Biagio, V. Murino, and D. Sona, "Kernel-based classification for brain connectivity graphs on the Riemannian manifold of positive definite matrices," in 2015 IEEE 12th International Symposium on Biomedical Imaging (ISBI), 2015. [16] M. Mijalkov, E. Kakaei, J. B. Pereira, E. Westman, and G. Volpe, "BRAPH: A graph theory software for the analysis of brain connectivity," PLOS ONE, vol. 12, no. 8, p. e0178798, Aug. 2017. [17] [18] K. Kira, L. A.Rendell, "The feature selection problem: traditional methods and a new algorithm," Aaai, vol. 2 , 1992. J. A. Brown, J. D. Rudie, A. Bandrowski, J. D. Van Horn, and S. Y. Bookheimer, "The UCLA multimodal connectivity database: a web-based platform for brain connectivity matrix sharing and analysis," Frontiers in Neuroinformatics, vol. 6, 2012. [19] D. Petrov,Y. Dodonova, L. Zhukov." Differences in Structural Connectomes between Typically Developing and Autism Groups.",INFORMATION TECHNOLOGIES AND SYSTEMS, 2015, pp. 763777. 8
1907.08326
1
1907
2019-07-19T00:40:28
I Stand With You: Using Emojis to Study Solidarity in Crisis Events
[ "cs.SI", "cs.CL" ]
We study how emojis are used to express solidarity in social media in the context of two major crisis events - a natural disaster, Hurricane Irma in 2017 and terrorist attacks that occurred on November 2015 in Paris. Using annotated corpora, we first train a recurrent neural network model to classify expressions of solidarity in text. Next, we use these expressions of solidarity to characterize human behavior in online social networks, through the temporal and geospatial diffusion of emojis. Our analysis reveals that emojis are a powerful indicator of sociolinguistic behaviors (solidarity) that are exhibited on social media as the crisis events unfold.
cs.SI
cs
I Stand With You: Using Emojis to Study Solidarity in Crisis Events Sashank Santhanam1*, Vidhushini Srinivasan1, Shaina Glass2, Samira Shaikh1 1Department of Computer Science, 2Department of Psychology University of North Carolina at Charlotte *[email protected] 9 1 0 2 l u J 9 1 ] I S . s c [ 1 v 6 2 3 8 0 . 7 0 9 1 : v i X r a Abstract We study how emojis are used to express sol- idarity in social media in the context of two major crisis events - a natural disaster, Hur- ricane Irma in 2017 and terrorist attacks that occurred in November 2015 in Paris. Using annotated corpora, we first train a recurrent neural network model to classify expressions of solidarity in text. Next, we use these expres- sions of solidarity to characterize human be- havior in online social networks, through the temporal and geospatial diffusion of emojis. Our analysis reveals that emojis are a power- ful indicator of sociolinguistic behaviors (sol- idarity) that are exhibited on social media as the crisis events unfold. 1 Introduction The collective enactment of online behaviors, includ- ing prosocial behaviors such as solidarity, has been known to directly affect political mobilization and so- cial movements [Tuf14, Fen08]. Social media, due to its increasingly pervasive nature, permits a sense of immediacy [Gid13] - a notion that produces high de- gree of identification among politicized citizens of the web, especially in response to crisis events [Fen08]. Furthermore, the multiplicity of views and ideologies that proliferate on Online Social Networks (OSNs) has created a society that is increasingly fragmented and polarized [DVVB+16, Sun18]. Prosocial behav- Copyright c(cid:13) 2018 held by the author(s). Copying permitted for private and academic purposes. In: S. Wijeratne, E. Kiciman, H. Saggion, A. Sheth (eds.): Pro- ceedings of the 1st International Workshop on Emoji Under- standing and Applications in Social Media (Emoji2018), Stan- ford, CA, USA, 25-JUN-2018, published at http://ceur-ws.org iors like solidarity then become necessary and essen- tial in overcoming ideological differences and finding common ground [Bau13], especially in the aftermath of crisis events (e.g. natural disasters). Recent so- cial movements with a strong sense of online solidar- ity have had tangible offline (real-world) consequences, exemplified by movements related to #BlackLivesMat- ter, #MeToo and #NeverAgain [DCJSW16, Bur18]. There is thus a pressing need to understand how soli- darity is expressed online and more importantly, how it drives the convergence of a global public in OSNs. Furthermore, research has shown that emoticons and emojis are more likely to be used in socio- emotional contexts [DBVG07] and that they may serve to clarify the message structure or reinforce the mes- sage content [MO17, DP17]. Riordan [Rio17] found that emojis, especially non-face emojis, can alter the reader's perceived affect of messages. While research has investigated the use of emojis over communities and cultures [BKRS16, LF16] as well as how emoji use mediates close personal relationships [KW15], the sys- tematic study of emojis as indicators of human behav- iors in the context of social movements has not been undertaken. We thus seek to understand how emojis are used when people express behaviors online on a global scale and what insights can be gleaned through the use of emojis during crisis events. Our work makes two salient contributions: • We make available two large-scale corpora1, an- notated for expressions of solidarity using muti- ple annotators and containing a large number of emojis, surrounding two distinct crisis events that vary in time-scales and type of crisis event. • A framework and software for analyzing of how emojis are used to express prosocial behaviors such as solidarity in the online context, through the study of temporal and geospatial diffusion of emojis in online social networks. 1https://github.com/sashank06/ICWSM_Emoji We anticipate that our approach and findings would help advance research in the study of online human behaviors and in the dynamics of online mobilization. 2 Related Work Defining Solidarity: We start by defining what we mean by solidarity. The concept of solidarity has been defined by scholars in relation to complementary terms such as "community spirit or mutual attachment, so- cial cooperation or charity" [Bay99]. In our work, we use the definition of expressional solidarity [Tay15], characterized as individuals expressing empathy and support for a group they are not directly involved in (for example, expressing solidarity for victims of nat- ural disasters or terrorist attacks). Using Emojis to Understand Human Behav- ior: With respect to research on expressional soli- darity, Herrera et al. found that individuals were more outspoken on social media after a tragic event [HVBMGMS15]. They studied solidarity in tweets spanning geographical areas and several languages re- lating to a terrorist attack, and found that hashtags evolved over time correlating with a need of individu- als to speak out about the event. However, they did not investigate the use of emojis in their analysis. Extant research on emojis usage has designated three categories, that are 1) function: when emo- jis replace a conjunction or prepositional word; 2) content: when emojis replace a noun, verb, or ad- jective; and 3) multimodal: when emojis are used to express an attitude, the topic of the message or communicate a gesture [NPM17]. [NPM17] found that the multimodal category is the most frequently used; and we contend that emojis used in the mul- timodal function may also be most likely to demon- strate solidarity. Emojis are also widely used to con- vey sentiment [HGS+17], including strengthening ex- pression, adjusting tone, expressing humor, irony, or intimacy, and to describe content, which makes emojis (and emoticons) viable resources for sentiment analysis [JA13, NSSM15, PE15]. We use sentiment of emojis to study the diffusion of emojis across time and region. To the best of our knowledge, no research to date has described automated models of detecting and clas- sifying solidarity expressions in social media. In ad- dition, research on using such models to further in- vestigate how human behavior, especially a prosocial behavior like solidarity, is communicated through the use of emojis in social media is still nascent. Our work seeks to fill this important research gap. and terrorist attacks in Paris, November 2015. We be- gin this section by briefly describing the two corpora. Irma Corpus: Hurricane Irma was a catastrophic Category 5 hurricane and was one of the strongest hur- ricanes ever to be formed in the Atlantic2. The storm caused massive destruction over the Caribbean islands and Cuba before turning north towards the United States. People took to social media to express their thoughts along with tracking the progress of the storm. To create our Irma corpus, we used Twitter streaming API to collect tweets with mentions of the keyword "irma" starting from the time Irma became an intense storm (September 6th, 2017) and until the storm weak- ened over Mississippi on September 12th, 2017 result- ing in a corpus of >16MM tweets. Paris Corpus: Attackers carried out suicide bombings and multiple shootings near cafes and the Bataclan theatre in Paris on November 13th, 2015. More than 400 people were injured and over a hun- dred people died in this event3. As a reaction to this incident, people all over the world took to social media to express their reactions. To create our Paris corpus, we collected >2MM tweets from 13th November, 2015 to 17th November, 2015 containing the word "paris" using the Twitter GNIP service4. Annotation Procedure We performed distance labeling [MBSJ09] by having two trained annota- tors assign the most frequent hashtags in our corpus with one of three labels ("Solidarity" (e.g. #soli- daritywithparis, #westandwithparis, #prayersforpuer- torico), "Not Solidarity" (e.g. #breakingnews, #face- book ) and "Unrelated/Cannot Determine" (e.g. #re- bootliberty, #syrianrefugees). Using the hashtags that both annotators agreed upon (κ > 0.65, which is re- garded as an acceptable agreement level) [SW05], we filtered tweets that were annotated with conflicting hashtags from both corpora, as well as retweets and duplicate tweets. Table 1 provides the descriptive statistics of the original (not retweets), non-duplicate tweets, that were annotated as expressing solidarity and not solidarity based on their hashtags that we used for further analysis. Table 1: Descriptive statistics for crisis event corpora # of Tweets Solidarity Not Solidarity Total Irma Paris 12000 20465 81697 29874 93697 50339 3 Data Collection Our analysis is based on social media text surround- ing two different crisis attacks: Hurricane Irma in 2017 2https://tinyurl.com/y843u5kh 3https://tinyurl.com/pb2bohv 4https://tinyurl.com/y8amahe6 4 The Emojis of Solidarity The main goal of this article is to investigate how in- dividuals use emojis to express a prosocial behavior, in this case, solidarity, during crisis events. Accord- ingly, we outline our analyses in the form of research questions (RQs) and the resulting observations in the sections below. RQ1: How useful are emojis as features in classifying expressions of solidarity? After performing manual annotation of the two cor- pora, we trained two classifiers for detecting solidarity in text. We applied standard NLP pre-processing tech- niques of tokenization, removing stopwords and lower- casing the tweets. We also removed hashtags that were annotated from the tweets. Class balancing was used in all models to address the issue of majority class im- balance (count of Solidarity vs. Not Solidarity tweets). Baseline Models: We used Support Vector Ma- chine (SVM) with a linear kernel and 10 fold cross validation to classify tweets containing solidarity ex- pressions. For the baseline models, we experimented with three variants of features including (a) word bi- grams, (b) TF-IDF [MPH08], (c) TF-IDF+Bigrams. RNN+LSTM Model: We built a Recurrent Neural Network(RNN) model with Long Short-Term Memory (LSTM) [HS97] to classify social media posts into Solidarity and Not Solidarity categories. The embedding layer of the RNN is initialized with pre- trained GloVe embeddings [PSM14] and the network consists of a single LSTM layer. All inputs to the net- work are padded to uniform length of 100. Table 2 shows the hyperparameters of the RNN model. Table 3 shows the accuracy of the baseline and RNN+LSTM models in classifying expressions of soli- darity from text, where the RNN+LSTM model with emojis significantly outperforms the Linear SVM mod- els in both Irma and Paris corpora. Table 2: RNN+LSTM model hyperparameters Hyperparameters Value Batch Size Learning Rate Epochs Dropout 25 0.001 20 0.5 RQ2: Which emojis are used in expressions of solidarity during crisis events and how do they compare to emojis used in other tweets? To start delving into the data, in Table 4 we show the total number of emojis in each dataset. We ob- serve that the total number of emojis in the tweets that express solidarity (using ground-truth human an- notation) is greater than the emojis in not solidar- ity tweets, even though the number of not solidarity Table 3: Accuracy of the baseline SVM models and RNN+LSTM model Accuracy RNN+LSTM (with emojis) RNN+LSTM (without emojis) TF-IDF TF-IDF + Bigrams Bigrams only Irma Paris 93.5% 86.7% 89.8% 86.1% 85.71% 75.72% 82.62% 76.98% 79.86% 75.24% tweets is greater than the solidarity tweets in both cri- sis events (c.f. Table 1). We also observe that count of emojis is greater in the Irma corpus than in the Paris corpus, even though the number of solidarity tweets is smaller in the Irma corpus. One reason for this could be that the Hurricane Irma event happened in 2017 when predictive emoji was a feature on platforms, while the Paris event occurred in 2015 when such func- tionality was not operational. Table 4: Total number of emojis in each dataset # of Emojis Solidarity Not Solidarity Total Irma Paris 26197 24801 25904 12373 52101 37174 Table 5: Top ten emojis by frequency and their counts in Irma and Paris corpora Rank Irma Sol. Irma Not Sol. Paris Sol. Paris Not Sol. 1 2 3 4 5 6 7 8 9 10 6105 2336 1977 1643 1530 1034 934 820 625 367 2098 1827 1474 1193 823 794 726 725 724 683 5376 2826 2649 2622 2581 2225 1702 386 340 259 2878 1033 909 779 760 616 513 510 433 361 To address RQ2, we show in Table 5 the top ten most frequently used emojis across both crisis events in the tweets that express solidarity and those that is used more frequently do not. We observe that in the Irma solidarity tweets (Rank 3) but not in the Irma tweets that do not express solidarity. In the top 10 Irma emojis used in tweets not expressing solidar- ity, we also observe more negatively valenced emojis, emoji is interesting, since including the prevailing meaning is "face with tears of joy", how- ever this emoji can sometimes be used to express sad- is used across all four ness [WBSD16]. In addition, . The and Figure 1: Cooccurrence network for emojis expressing solidarity from regions affected by Hurricane Irma Figure 2: Cooccurrence network for emojis expressing solidarity from regions not affected by Hurricane Irma sets, albeit at different ranks (e.g. Rank 1 in Irma solidarity and Rank 6 in Paris solidarity tweets). ) at Rank 1, while When comparing the two crisis events, we make the observation that the top 5 ranked Paris solidar- ity emojis are flags of different countries, related to expressions of solidarity from these countries, includ- appears at Rank ing France ( 9 in the Irma solidarity set. We can thus observe that even though the underlying behavior we study in these two events is solidarity, the top emojis used to express such behavior are different in the two events. Dur- ing the Paris event, solidarity is signaled through the use of flag emojis from different countries, while in the Irma corpus flag emojis do not play a prominent role. RQ3: Which emojis coocur in tweets that are posted within areas directly affected by crisis events as compared to those tweets that are posted from other areas? This research question and the two following RQs are driven by the hypothesis that solidarity would be expressed differently by people that are directly af- fected by the crisis than those who are not [Bue16]. To address RQ3, we first geotagged tweets using geopy Python geocoding library5 to map the users' locations to their corresponding country. Table 6 shows the to- tal number of emojis in solidarity tweets that were geotagged and categorized as posted within regions affected by the event vs. other regions. We then built co-occurrence networks of emojis in both Irma and Paris corpora using the R ggnetwork package6 with the force-directed layout to compare these emoji co-occurrence networks in solidarity tweets that were posted within areas directly affected by the crisis and the areas that were not (shown in Figures 1-4). 5https://github.com/geopy/geopy 6https://tinyurl.com/y7xnw9lr Table 6: Total count and proportion of emojis in geo- tagged tweets from affected vs. other regions Affected Regions Other Regions Irma 10048 (67.81%) 4770 (32.19%) Paris 925 (6.52%) 13267 (93.48%) Figure 1 represents the co-occurrence network of emojis within the regions affected by the Hurricane Irma (United States, Antigua and Barbuda, Saint Martin, Saint Barthelemy, Anguilla, Saint Kitts and Nevis. Birgin Islands, Dominican Republic, Puerto Rico, Haiti, Turks and Caicos and Cuba)7. -- We find the pair occurs most frequently in solidarity tweets collected within the Irma affected regions. The other top co-occurring pairs following the sequence include -- ; these pairs might convey the concerns expressed in and -- -- -- , , the tweets that originate within affected areas. The emoji appears at the centre of the network denoting the impact of the Irma event. The -- network. The to stay strong during this hurricane calamity. are the emojis that appear in isolation from the emojis can serve as indicators and -- -- , , -- Figure 2 represents the co-occurrence network of emojis in tweets posted outside the regions affected by Hurricane Irma. We find that the pair tops the co-occurrence list. Next, we have other co-occurring pairs like following the top most frequent pair in sequence. We see the three disjoint networks apart from the main co-occurrence network. emoji appears at the centre of the network The expressing sorrow and the concern of the people during the event. The disjoint networks also contain flags and and -- -- 7http://www.bbc.com/news/world-us-canada-41175312 Figure 3: Cooccurrence network for emojis express- ing solidarity from regions affected by November 2015 terrorist attacks in France Figure 4: Cooccurrence network for emojis expressing solidarity from regions not affected by November 2015 terrorist attacks in France other emojis that express sadness and sorrow. -- -- -- and Figure 3 shows the co-occurrence network of emo- jis for November terrorist attacks in France. Within tops all the co-occurrence France, the pair pairs. Co-occurrence pairs like fol- low the top co-occurring sequence, strongly conveying the solidarity of people who tweeted during Novem- ber terrorist attacks. We also have co-occurring pairs containing flags of other countries following the top- tweeted list that shows uniform feeling among the peo- ple by trying to express their sorrow and prayers. The emoji appears in the centre of the large network as an expression of danger during terrorist attacks. We can also see that the network contains many flags that indicates the concern and worries of people from many different countries. There are five disjoint net- works that again contain emojis that express the sor- row, prayers and discontent. -- -- -- and Figure 4 represents the co-occurrence network of emojis for November terrorist attacks in Paris outside France. We find that the pair tops the co- occurrence list as within France, which is followed by the co-occurring pairs . We can infer that the people within or outside France shared common emotions that includes a mixture of prayers, support and concern towards Paris and its people. We appear at the centre of the net- find the work to convey solidarity. The emoji also appears at the center, similar to Figure 1. One important in- emoji appears at the network ference is that the center Irma affected regions whereas it appears at the network center for unaffected regions in Paris event. and , RQ4: How can emojis be used to under- stand the diffusion of solidarity expressions over time? For addressing this research question, we plot in Figures 5 and 6 the diffusion of emojis across time (filtering emojis that occur fewer than 50 times and 25 times per day resp. for the 26197 emojis in Irma and 24801 emojis in the Paris solidarity corpus (c.f. Table 4). The emojis are arranged on y-axis based on their sentiment score based on the publicly available work done by Novak et al. [NSSM15]. and and In the Irma corpus, the temporal diffusion of emo- jis is quite interesting (Figure 5). Hurricane Irma grabbed attention of the world on September 6th when it turned into a massive storm and the reaction on so- cial media expressing solidarity for Puerto Rico was through . During the following days, the United States is in the path of the storm, and there is an increased presence of and the presence of other countries flags. As the storm lashes out on the is- lands on September 7th, people express their feelings through emojis and also warn people about caring for the pets. As the storm moves through the Atlantic, more prayers with emojis emerge on social media for people affected and on the path of this storm. The storm strikes Cuba and part of Ba- hamas on September 9th before heading towards the Florida coast. As the storm moves towards the US on September 10th, people express their thoughts through causing tornadoes. When images of mas- sive flooding emerge on social media, people respond to save them. with pet emojis like The emoji may also serve as an indicator of high- pitched crying [WBSD16]. and and and , , , In the Paris attacks, the first 24 hours from 13th night to 14th were the days on which most number of emojis were used. When news of this horrible attack spreads on social media, the immediate reaction of the Figure 5: Diffusion of emojis across time for the Hur- ricane Irma disaster (N=26197 emojis) Figure 6: Diffusion of emojis across time for the November Paris attacks (N=24801 emojis) emoji. As a result, people was to express solidarity through hashtags at- tached with was the most frequently used emoji across all days. Emojis of other country flags such as emerge to indicate solidar- ity of people from these countries with France. Even after the end of the attack on Nov 13th, people express prayers for the people of France through emoji. Im- ages and videos of the attacks emerge on social media on Nov 14th leading to the use of the emoji. The , emoji occurs across all days for the Paris event. Across both events, we also observe a steady pres- ence over all days of positively valenced emojis in the tweets expressing solidarity (the top parts of the diffu- sion graphs), while negatively valenced emojis are less prevalent over time (e.g. appears in the first two and three days in the Irma and Paris events resp.). RQ5: How can emojis be used to study the temporal and geographical difussion of solidar- ity expressions during crisis events? Our primary aim with this research question was to look at how the emojis of solidarity diffuse over time within the affected community and compare commu- nities not affected by the same event. Using the geo- tagged tweets described in RQ2, we created Figures 7 and 8 to represent the diffusion of emojis over time within the affected regions on the path of Hurricane Irma and the non-affected regions respectively. Since the distribution of emojis in geotagged tweets for the Paris attacks is skewed (6.52% emojis expressing sol- idarity from affected regions, c.f. Table 6), we have excluded the Paris event for analysis in this RQ. Figures 7 and 8 allow us to contrast how the Hur- ricane Irma event is viewed within and outside the affected regions. On September 6th, emerged when the hurricane started battering the islands along with a lot of heart emojis. On the other hand, more heart emojis emerged expressing solidarity from outside the affected regions when the people realized the effect of the hurricane (Sep 7th. As the storm moved forward, people in the affected regions express a lot of prayers. On September 9th, as the storm moves towards the United States after striking Cuba, there seems to be more prayers amongst affected as well as outside communities. The emoji is constant in the affected regions. In both Figures 8 and 7, we see that variety of emojis appear in the latter days of the event (starting Sep 9th), including the as well as the animal/pet emojis, likely indicating the emergence of different topics of discourse related to the event. , and , 5 Conclusion and Future Work We described our data, algorithm and method to ana- lyze corpora related to two major crisis events, specif- ically investigating how emojis are used to express solidarity on social media. Using manual annota- tion based on hashtags, which is a typical approach taken to distance label social media text from Twit- ter [MBSJ09], we categorized tweets into those that express solidarity and tweets that do not express sol- Figure 7: Diffusion of emojis across time for the Hur- ricane Irma within affected regions (N=10048 emojis) Figure 8: Diffusion of emojis across time for the Hur- ricane Irma outside affected regions (N=4770 emojis) idarity. We then analyzed how these tweets and the emojis within them diffused in social media over time and geographical locations to gain insights into how people reacted globally as the crisis events unfolded. We make the following overall observations: • Emojis are a reliable feature to use in classifica- tion algorithms to recognize expressions of soli- darity (RQ1). • The top emojis for the two crisis event reveal the differences in how people perceive these events; in the Paris attack tweets we find a notable presence of flag emojis, likely signaling nationalism but not in the Irma event (RQ2). • Through the cooccurence networks, we observe that the emoji pairs in tweets that express sol- idarity include anthropomorphic emojis ( , ) with other categories of emojis such as and (RQ3). , • Through analyzing the temporal and geospatial diffusion of emojis in solidarity tweets, we observe a steady presence over all days of positively va- lenced emojis, while negatively valenced emojis become less prevalent over time (RQ4, RQ5). Future Work: While this paper addressed five salient research questions related to solidarity and emojis, there are a few limitations. First, our dataset contains emojis that number in the few thousand, which is relatively small when compared to extant re- search in emoji usage [LF16]. However, we aim to reproduce our findings on larger scale corpora in the future. Second, we analyzed solidarity during crisis events including a terrorist attack and a hurricane, whereas solidarity can be triggered without an overt shocking event, for example the #MeToo movement. In future work, there is great potential for further in- vestigation of emoji diffusion across cultures. In ad- dition to categorizing tweets as being posted from af- fected regions and outside of affected regions, we wish to analyze the geographical diffusion with more granu- larity, using countries and regions as our units of anal- ysis to better understand the cultural diffusion of sol- idarity emojis. An additional future goal is to analyze the interaction of sentiment of emojis and solidarity as well as the text that cooccurs with these emojis in further detail. We anticipate our approach and find- ings will help foster research in the dynamics of on- line mobilization, especially in the event-specific and behavior-specific usage of emojis on social media. Acknowledgements We are grateful for the extremely helpful and con- structive feedback given by anonymous reviewers. We thank the two trained annotators for their help in cre- ating our dataset. This research was supported, in part, by a fellowship from the National Consortium of Data Science to the last author. References [Bau13] Zygmunt Bauman. Postmodernity and its Discontents. John Wiley & Sons, 2013. [Bay99] [BKRS16] [Bue16] [Bur18] [DBVG07] [DCJSW16] [DP17] [DVVB+16] [Fen08] Kurt Bayertz. Four uses of solidarity. In Solidarity, pages 3 -- 28. Springer, 1999. [Gid13] Anthony Giddens. The consequences of modernity. John Wiley & Sons, 2013. Barbieri, German Francesco Francesco Ronzano, Kruszewski, How cos- and Horacio Saggion. mopolitan are emojis?: Exploring emojis usage and meaning over dif- ferent languages with distributional semantics. In Proceedings of the 2016 ACM on Multimedia Conference, pages 531 -- 535. ACM, 2016. Steven M Buechler. Understanding social movements: Theories from the classical era to the present. Rout- ledge, 2016. INQUIRER.net US Bureau. #nev- eragain walkouts spark half a million social media posts in 24 hours, Mar 2018. Daantje Derks, Arjan ER Bos, and Jasper Von Grumbkow. Emoticons and social interaction on the inter- net: the importance of social con- text. Computers in human behavior, 23(1):842 -- 849, 2007. Munmun De Choudhury, Shagun Jhaver, Benjamin Sugar, and Ingmar Weber. Social media participation in an activist movement for racial equal- ity. In ICWSM, pages 92 -- 101, 2016. Giulia Donato and Patrizia Paggio. Investigating redundancy in emoji use: Study on a twitter based cor- pus. In Proceedings of the 8th Work- shop on Computational Approaches to Subjectivity, Sentiment and Social Media Analysis, pages 118 -- 126, 2017. Michela Del Vicario, Gianna Vivaldo, Alessandro Bessi, Fabiana Zollo, An- tonio Scala, Guido Caldarelli, and Walter Quattrociocchi. Echo cham- bers: Emotional contagion and group polarization on facebook. Scientific reports, 6:37825, 2016. Natalie Fenton. Mediating solidar- ity. Global Media and Communica- tion, 4(1):37 -- 57, 2008. [HGS+17] [HS97] Tianran Hu, Han Guo, Hao Sun, Thuy-vy Thi Nguyen, and Jiebo Luo. Spice up your chat: The intentions and sentiment effects of using emoji. arXiv arXiv:1703.02860, 2017. preprint Sepp Hochreiter and Jurgen Schmid- huber. Long short-term memory. Neural computation, 9(8):1735 -- 1780, 1997. [HVBMGMS15] Enrique Herrera-Viedma, Carlos Juan Bernabe-Moreno, Porcel Gallego, and Maria de los Angeles Martinez Sanchez. Solidarity in so- cial media: when users abandon their comfort zone-the charlie hebdo case. REVISTA ICONO 14-REVISTA CI- ENTIFICA DE COMUNICACION Y TECNOLOGIAS, 13(2):6 -- 22, 2015. [JA13] [KW15] [LF16] [MBSJ09] Ahmed and Tanimu Jibril Rel- Mardziah Hayati Abdullah. evance of emoticons in computer- mediated communication contexts: An overview. Asian Social Science, 9(4):201, 2013. Ryan Kelly and Leon Watts. Char- acterising the inventive appropria- tion of emoji as relationally meaning- ful in mediated close personal rela- tionships. Experiences of Technology Appropriation: Unanticipated Users, Usage, Circumstances, and Design, 2015. Nikola Ljubesi´c and Darja Fiser. A global analysis of emoji usage. In Proceedings of the 10th Web as Cor- pus Workshop, pages 82 -- 89, 2016. Mike Mintz, Steven Bills, Rion Snow, and Dan Jurafsky. Distant super- vision for relation extraction with- out labeled data. In Proceedings of the Joint Conference of the 47th An- nual Meeting of the ACL and the 4th International Joint Conference on Natural Language Processing of the AFNLP: Volume 2-Volume 2, pages 1003 -- 1011. ACL, 2009. [MO17] [MPH08] [NPM17] [NSSM15] [PE15] [PSM14] [Rio17] [Sun18] [SW05] [Tay15] Kris M Markman and Sae Os- hima. Pragmatic play? some pos- sible functions of english emoticons and japanese kaomoji in computer- mediated discourse. 2017. Christopher Manning, Raghavan Prabhakar, and Schutze Hinrich. In- troduction to information retrieval. An Introduction To Information Retrieval, 151:177, 2008. Noa Na'aman, Hannah Provenza, and Orion Montoya. Varying linguis- tic purposes of emoji in (twitter) con- text. In Proceedings of ACL 2017, Student Research Workshop, pages 136 -- 141, 2017. [Tuf14] [WBSD16] Zeynep Tufekci. Social move- ments and governments in the digi- tal age: Evaluating a complex land- scape. Journal of International Af- fairs, pages 1 -- 18, 2014. Sanjaya Wijeratne, Lakshika Bala- suriya, Amit Sheth, and Derek Do- ran. Emojinet: Building a ma- chine readable sense inventory for emoji. In International Conference on Social Informatics, pages 527 -- 541. Springer, 2016. Novak, Borut Jasmina Petra Kralj Smailovi´c, and Igor Mozetic. Sentiment of emojis. PloS one, 10(12):e0144296, 2015. Sluban, Umashanthi Pavalanathan and Ja- Emoticons vs. cob Eisenstein. emojis on twitter: A causal in- ference approach. arXiv preprint arXiv:1510.08480, 2015. Jeffrey Pennington, Richard Socher, and Christopher Manning. Glove: Global vectors for word representa- tion. In Proceedings of the 2014 con- ference on empirical methods in nat- ural language processing (EMNLP), pages 1532 -- 1543, 2014. Monica A Riordan. The communica- tive role of non-face emojis: Affect and disambiguation. Computers in Human Behavior, 76:75 -- 86, 2017. Cass R Sunstein. # Republic: Di- vided democracy in the age of social media. Princeton University Press, 2018. Julius Sim and Chris C Wright. The kappa statistic in reliability stud- ies: use, interpretation, and sample size requirements. Physical therapy, 85(3):257 -- 268, 2005. Ashley E Taylor. Solidarity: Obli- gations and expressions. Journal of Political Philosophy, 23(2):128 -- 145, 2015.
1709.00372
1
1709
2017-09-01T15:45:41
Drawing Dynamic Graphs Without Timeslices
[ "cs.SI", "cs.HC" ]
Timeslices are often used to draw and visualize dynamic graphs. While timeslices are a natural way to think about dynamic graphs, they are routinely imposed on continuous data. Often, it is unclear how many timeslices to select: too few timeslices can miss temporal features such as causality or even graph structure while too many timeslices slows the drawing computation. We present a model for dynamic graphs which is not based on timeslices, and a dynamic graph drawing algorithm, DynNoSlice, to draw graphs in this model. In our evaluation, we demonstrate the advantages of this approach over timeslicing on continuous data sets.
cs.SI
cs
Drawing Dynamic Graphs Without Timeslices Paolo Simonetto1, Daniel Archambault1, and Stephen Kobourov2 [email protected],[email protected] 1 Swansea University, UK 2 University of Arizona, US [email protected] Abstract. Timeslices are often used to draw and visualize dynamic graphs. While timeslices are a natural way to think about dynamic graphs, they are routinely imposed on continuous data. Often, it is un- clear how many timeslices to select: too few timeslices can miss temporal features such as causality or even graph structure while too many times- lices slows the drawing computation. We present a model for dynamic graphs which is not based on timeslices, and a dynamic graph drawing algorithm, DynNoSlice, to draw graphs in this model. In our evaluation, we demonstrate the advantages of this approach over timeslicing on con- tinuous data sets. 1 Introduction Graphs offer a natural way to represent a static set of relations. In order to encode changes to a graph over time, static graphs can be extended to dynamic graphs. Dynamic graphs are traditionally thought of as a sequence of static graphs in a finite number of moments in time, or timeslices. We refer to these dynamic graphs as discrete dynamic graphs. Discrete dynamic graphs are widely used for several reasons. Drawing timesliced graphs is similar to drawing static graphs, allowing force-directed approaches to be easily adapted to dynamic data. Also, timeslicing works fine for data that changes at discrete, regular time intervals. Algorithms to draw discrete dynamic graphs strike a balance between graph drawing readability and stability [3]. Readability requires the drawing of indi- vidual timeslices to be of high quality while stability (mental map preservation) requires nodes to not move too much between consecutive timeslices for easy identification [2]. These requirements conflict with each other as node movement is required for timeslice readability, while it negatively impacts stability. Approaches for discrete dynamic graph drawing extend static graph draw- ing algorithms. Each timeslice is a static graph that is drawn considering the timeslices before and after to stabilize the transition. However, when the time dimension is continuous, there are no timeslices. Thus, evenly spaced timeslices are selected and the graph elements are projected to the closest one. This oper- ation implicitly aggregates data along the time dimension (Fig. 1). Selecting too many timeslices leads to slow layout computation while selecting too few leads to information loss due to projection errors when events are of short duration, obscuring graph structure. Even for graphs with nodes and edges that span long periods of time, regular timeslices can obscure important temporal patterns. (a) Discrete Dynamic Graph (b) Continuous Dynamic Graph Fig. 1: A dynamic graph with 5 nodes. (a) A discrete representation with nodes pro- jected onto timeslices. Projecting the nodes (purple dots) results in information loss due to aggregation across time. (b) In our approach, nodes are defined as piecewise linear curves in the space-time cube, as timeslices are not imposed on continuous data. A natural solution to the problems above would be to refrain from imposing timeslices on the continuous data and draw the graph directly along a continuous time dimension. In a recent state-of-the-art report, Beck et al. [7, p. 15] states "the effects of using continuous time with arbitrary fine sampling rates, rather than discretized time, are largely unexplored". In this paper, we introduce a model for dynamic graph drawing that does not use timeslices. We call these graphs continuous dynamic graphs and propose the first dynamic graph drawing algorithm, DynNoSlice, to draw them along a continuous time dimension. 2 Related Work Dynamic graphs visualization is a well established field of research, as shown in the recent survey by Beck et al. [7]. If we were to place our approach in this model, it would be an "offline time-to-time mapping" without timeslices, as it works with full knowledge of the input data. Related approaches also include the "superimposed time-to-space mapping", as this approach inherently defines a space-time cube. Offline Drawing. Offline dynamic graph drawing algorithms capture all of the dynamic data beforehand and optimize across it simultaneously. Foresighted layout algorithms [17, 18] are among the first attempts at offline dynamic graph drawing. They create a supergraph as the union of the elements at each timeslice. The supergraph is then used to define the position of nodes and edge bends. Mental map preservation is the primary focus of this approach. Brandes and Corman [8] designed an approach for offline dynamic graph drawing that visually refers to time as a third, discrete spacial component. Timeslices are placed on top of each other, forming a layered space-time cube. A similar technique is also used by Dwyer and Eades [19]. In both approaches, the time dimension is modeled using timeslices. Erten et al. [21] explored several ways to superimpose different graphs, in- cluding the use of different colors for different timeslices of a layered space-time cube. In GraphAEL [20, 23], the space-time cube was created by connecting the same nodes in consecutive timeslices with inter-timeslice edges and optimiz- ing this structure with a force-directed algorithm. A similar technique is used by Discretised timeSpaceTime123456abcdeaaaabcde123456Continuos timeSpaceTimeabcdeabcdeace1.85.7 Groh et al. [30] and by Itoh et al. [32] for social networks. Brandes and Mader [9] perform a metric-based evaluation of several strategies for drawing discrete dy- namic graphs including aggregation, anchoring, and linking. Linking strategies performed best in balancing drawing quality (measured using stress) and mental map preservation (measured using distance traveled). Rauber et al. [43], iden- tify vectors vi[t] in the cost gradient whose geometrical interpretation would be identical when working in a layered space-time cube. Our approach can be seen as an extension of offline discrete dynamic graph drawing approaches to continuous time. However, the difference is substantial as in related work timeslices are imposed on the data. By drawing in continuous time, each node and edge defines its own trajectory with its own complexity whereas discrete algorithms impose linear interpolations between timeslices. Time-to-space mapping approaches [7] use one dimension for space and one dimension for time in order to visualize the network [12, 36, 45, 49]. Recent scal- able approaches use dimensionality reduction to show time as a curve in the plane [6, 50]. By using spatial dimensions to represent time, these visualizations are substantially different from classic dynamic node-link diagrams. Online Drawing. Given an incoming stream of data, online drawing algo- rithms continuously update the current graph drawing to take into account new data. Misue et al. [37] optimize mental map preservation by maintaining the horizontal and vertical order of the nodes through adjustments. Frishman and Tal [25] proposed a different force-directed algorithm which could also be par- tially executed on the GPU. Gorochowski et al. [28] use node aging to decide how much a node position should be preserved at a given time. Finally, Crnovrsanin et al. [14] adapted the FM3 [31] multilevel approach to an online setting. Although related, online approaches are different as they operate under more stringent constraints due to lack of access to future information. Offline algo- rithms, such as DynNoSlice, use the full knowledge of the graph evolution. 3D Graph Drawing. Several 2D algorithms have been extended to 3D. Bruss and Frick [11] proposed Gem3D, which extends Gem [24] to 3D. Cruz and Twarog [15] extended the simulated annealing approach of Davidson and Harel [16] to 3D. Other algorithms work in both 2D and 3D, such as GRIP by Gajer and Kobourov [26]. Munzner [38] proposed an algorithm to draw directed graphs in a 3D hyperbolic space. Several other algorithms deal with particular constraints, such as orthogonal [34], or nested [41] drawings. Cordeil et al. [13] investigate the visualization of graphs in 3D using immersive environments. Although our approach does compute a 3D layout of the dynamic graph, we do not produce a 3D visualization. Since our third dimension is time, nodes and edges have additional constraints and are not free to move arbitrarily in 3D. Space-Time Cubes. Sallaberry et al. [44] visualize dynamic graphs by ma- nipulating the space-time cube. Several other information visualization methods perform similar operations in the space-time cube, as discussed in Bach et al. [5]. These approaches assume that the space-time cube is already given and focus on how to accommodate it in 2D, whereas our approach constructs the space-time cube for dynamic graphs using a continuous time dimension. (a) (b) (c) Fig. 2: A continuous dynamic graph in the space-time cube. (a) Position attribute for a node v. (b) The appearance attribute. (c) An edge in a continuous dynamic graph, as encoded by the edge appearance attribute. 3 Continuous Dynamic Graph Model Let G = (V, E) be a static graph defined with node set V and edge set E ⊆ V ×V . We define attributes (functions) on the nodes and edges of the graph that encode characteristics such as their positions, weights, and labels. The node position attribute (PG : V → R2) maps a node v into its position in the 2D plane pv, e.g., PG(v) = (1, 4). This attribute is not integral to our model of continuous dynamic graphs, but is used to compute and store the layout of these graphs. We define a continuous dynamic graph D = (V, E) as a graph whose at- tributes are also a function of time. Let T be the time domain defined as an interval in R. Attributes are functions defined in the domain V × T for nodes, and E × T for edges. For example, the node position attribute PD : V × T → R2 is the function that describes the position of v for each time t ∈ T . We assume (w.l.o.g.) that the node and edge attributes can be defined piecewise, e.g.: PD(v, t) = Pv(t) =  Pv,1(t) ... Pv,n(t) pv,ω for t ∈ T1 for t ∈ Tn otherwise disjoint intervals of time Ti, with a default value returned for t /∈(cid:83) In other words, a dynamic attribute can be thought of as a map that links each node (edge) to a sequence of functions Pv,i that describe its behavior in i Ti. In the rest of paper we consider only piecewise linear functions for nodes and edges. Attributes specify a variety of node and edge characteristics. For data that can be meaningfully interpolated (e.g., colors, weights, positions), the functions above can be described by initial and final values. For attributes without mean- ingful interpolation (e.g., labels), we prefer functions that are constant in the related interval. Position and label attributes for a node v of D can be:  Pv(t) = (1, 0) → (4, 0) (2,−2) → (5, 1) (5, 1) → (4, 5) (0, 0) for t ∈ (9, 12] for t ∈ (12, 15] for t ∈ [17, 19] otherwise Lv(t) = Jane Doe for t ∈ (10, 11] Jane Smith for t ∈ (11, 16] unknown otherwise XTimeY(1,0,9)(4,0,12)(2,-2,12)(5,1,15)XTimeY(1,0,9)(4,0,12)(2,-2,12)(3,-1,13)(0,0,2)(0,0,7)XTimeYaba We define the attribute appearance that implements the classic dynamic graph operations node/edge insertion and deletion. for t ∈ [2, 7) for t ∈ (9, 13] otherwise true true false Av(t) = In order to mark an edge e = (u, v) as present in Tx, we need to ensure that both u and v are present for the entire Tx. This definition supports changes in node (edge) characteristics at any time, whereas discrete dynamic graphs allow changes only to occur in timeslices. Dyn- NoSlice implements the above model as a collection of piecewise, linear functions defined on intervals in the space-time cube. Fast access to these functions at any given time is required. In our implementation, we use interval trees. When the intervals are guaranteed to be non-overlapping, simpler structures such as binary search trees can be used. 4 DynNoSlice Implementation A continuous dynamic graph D can be transformed into a 3D static graph D(cid:48) by embedding it in the space-time cube. Algorithms for static or discrete dynamic graphs can be extended to work with this new representation. In this section, we describe our force-directed algorithm for drawing continuous dynamic graphs. It has been implemented and the source code is available3. 4.1 Representation in the Space-Time Cube We can define a space-time cube transformation (STCT) that transforms a continuous dynamic graph into a drawing in the space-time cube. In D(cid:48), the presence and position of each node is represented by a sequence of trajectories. The shapes of these trajectories are defined by the position attributes. In the example above, the trajectory of v is defined by three line segments, (1, 0, 9) → (4, 0, 12), (2,−2, 12) → (5, 1, 15) and (5, 1, 17) → (4, 5, 19), and by portions of the line (0, 0, x) (see Fig. 2a). The number of these trajectories is also affected by the appearance attribute. In the example above, the node v appears two times: at [2, 7) and at (9, 13]. Clearly, the behavior of the node at times when it is not part of the graph is non-influential. Therefore, the node appearance and position in the space-time cube can be identified by the segments sv,1 = (0, 0, 2) → (0, 0, 7), sv,2 = (1, 0, 9) → (4, 0, 12) and sv,3 = (2,−2, 12) → (3,−1, 13) (see Fig. 2b). The trajectory given by the polyline is made of the start and end points, as well as the bends (the junctions of consecutive segments). The representation of edges in the space-time cube is less intuitive. By con- necting two trajectories with lines in the space-time cube, we obtain a ruled surface. Therefore, an edge e = (u, v) is a surface that connects trajectories u and v for a duration indicated by Ae. If the node trajectories are not continuous 3 http://cs.swan.ac.uk/dynnoslice/software.html as in the above example: t→12− Pv(t) = (4, 0) lim and lim t→12+ Pv(t) = (2,−2), an edge might create two or more surfaces (see Fig. 2c). If the trajectory segments, considered as vectors, form an acute angle with respect to the positive time axis, this transformation is easily invertible. Thus, trajectory segments cannot fold back on themselves, as it would identify multiple positions for that node at a given time. We can then work on this continuous dynamic graph in 3D as if it were a static graph as follows: Da → STCT → D(cid:48) a → Operation → D(cid:48) b → STCT−1 → Db 4.2 Force-Directed Drawing Algorithm Our force-directed algorithm is based on earlier variants by Simonetto et al. [46, 47]. As in most force-directed algorithms, after an initialization phase, the algorithm iteratively improves the current layout of the drawing in 3D for a given number of iterations in the following way: – For each iteration of the algorithm: • Compute and sum the forces based on the force system. • Move nodes based on these forces and the constraints. • Adjust trajectory complexity in the space-time cube. Initialization Each node v is randomly assigned a position (a, b) in the 2D plane. The points defining v's trajectory are extruded linearly along the time axis (a, b, x), where x is the time coordinate. Forces DynNoSlice has five forces. The first three forces adapt standard, force- directed approaches to work with trajectories in the space-time cube. The final two are novel for continuous dynamic graph drawing. In our notation, a star transforms 3D vector to 2D by dropping the time coordinate. For example, if p = (1, 2, 3) then p∗ is (1, 2). The parameter δ is an ideal distance between two node trajectories. 1. Node Repulsion. This force repels trajectories from each other. The force evenly distributes node trajectories in space and prevents crowding [35, 42]. For each segment endpoint a in the trajectory of node u and segment sv,j = c → d of node v, with u (cid:54)= v, we compute the forces generated on the points a, c and d (see Fig. 3). If the points a, c and d are not collinear and (p ∈ sv,j), they form a plane. In this case, we apply the force EdgeNodeRepulsion(δ) described in previous work [47], except node positions are in 3D. If the points are collinear or the projection p of a does not fall in the segment sv,j (p /∈ sv,j), we apply NodeNodeRepulsion(δ) [47] between a and c and between a and d. Since distant segments do not interact significantly, they can be ignored to reduce the running time. A multi-level interval tree is used to identify segments that are sufficiently close (< 5δ). All other pairs are ignored. (a) (b) (c) (d) (e) Fig. 3: Forces and constraints. (a) and (b) Node repulsion force between point a and the line segment c → d that represents the trajectories of nodes u and v. (c) and (d) Edge attraction for an edge in the interval highlighted with yellow background. (e) Time movement restriction. Endpoints (a and c) must keep their assigned time coordinates. Bend b cannot move past half the distance with other bends or endpoints. 2. Edge Attraction. This attractive force pulls trajectories that are linked by an edge closer to each other. The force is exerted only for the intervals where the edge is present. Let us consider an edge e = (u, v) that appears at interval (t1, t2) and let I = (t1τ, t2τ ) be the transformed time interval in the space-time cube with conversion factor τ that transforms time into the third dimension of the space time cube. For each pair of segments su,i = a → b and sv,j = c → d that overlap with the interval (f, g), we compute the points m, n of segment su,i and p, q of segment sv,j so that: min(cid:8)f ∈ I : ∃m ∈ su,i, ∃p ∈ sv,j, f = m[2] = p[2](cid:9) max(cid:8)g ∈ I : ∃n ∈ su,i, ∃q ∈ sv,j, g = n[2] = q[2](cid:9) where x[2] is the time coordinate of the point x in the space-time cube. We compute the attractive force between the points m and p, and n and q, using EdgeContraction(δ) [47] (see Fig. 3c). This force is applied to the segment end- points once scaled by its distance from the application point and by the coverage of the edge appearance on the segment (see Fig. 3d). For example, if the force Fm attracts m to p, then Fa applied to a will be: Fa = Fm ∗ a[2] − m[2] a[2] − b[2] ∗ n[2] − m[2] a[2] − b[2] . 3. Gravity. This force encourages a compact drawing of node trajectories. Let c be the center in 2D of the initial node placement in the space-time cube. The gravity F of each segment endpoint a is F = c∗ − a∗. 4. Trajectory Straightening. This force smooths node trajectories, helping with node movements over time. For trajectory bends, we use the CurveSmooth- ing [47] force, which pulls a bend b to the centroid of the triangle ∆abc formed by using the previous and next bends or endpoints a and c. A trajectory endpoint a has no such triangle. Therefore, it is pulled in 2D toward the midpoint of the segment formed with the closest bend or endpoint b. 5. Mental Map Preservation. This force prevents trajectory segments from making large angles with respect to time. When segments form a 90° angle with time, a node essentially "teleports" from one place to another, while segments parallel to the time axis result in no node movement. Thus, segments should form small angles with the time axis. This force pulls endpoints a and b of each trajectory towards each other in 2D with a magnitude based on the angle α the segment makes with the time axis: Fa = (b∗ − a∗) ∗ α 90° − α Constraints Node movement constraints ensure valid drawing of the continuous dynamic graph in the space-time cube. In particular, constraints are needed to prevent undesired movements. Decreasing Max Movement. We insert a constraint on the maximum node movement allowed at each iteration. This allows large movements at the begin- ning of the computation, and smaller refinements towards the end. This con- straint is similar to DecreasingMaxMovement(δ) [47]. Movement Acceleration. This constraint promotes consistent movements with previous iterations and penalizes movements in the opposite direction. This con- straint corresponds to MovementAcceleration(δ) [47]. Time Correctness. This constraint prevents a node from changing its time coordinate. Consider the trajectory formed by the segment t = a → b. If a changes its time coordinate in the space-time cube, the time of its appear- ance will also change. Now, consider a trajectory formed by several segments, t = a → b → c → d. The trajectory endpoints a and d, corresponding to the appearance and disappearance of the node, should have fixed time positions. However, bends b and c can move in time, so long as they do not pass each other (a[2] < b[2] < c[2] < d[2]) as this would result in a node being in two locations at once. Therefore, the movement Ma of node a in time is constrained to be: Ma ← M∗ a if a is the endpoint of a trajectory, and (cid:27) < rMb[2] < Mc[2] − Mb[2] 2 (cid:26) Mb ← Mb ∗ max r ∈ [0, 1] : Ma[2] − Mb[2] 2 if b is a trajectory bend between other bends or endpoints a and c (see Fig. 3e). Complexity Adjustment of Node Trajectories As bends move freely in time and space, node trajectories can be oversampled or undersampled. There- fore, bends can be inserted or removed from the polyline representing a node trajectory. If a segment of the trajectory between bends a and b is greater than a threshold (2δ in this paper), a bend is inserted at its midpoint. Similarly, if two consecutive segments ab and bc are placed such that the distance between a and c is less than a threshold (1.5δ in this paper), the bend b is removed and the two segments are replaced by ac. 5 Evaluation We perform a metric-based evaluation of our approach against the state-of-the- art algorithm visone [10] to demonstrate the advantages of our model. 5.1 Data Sets InfoVis Co-Authorship (Discrete): a co-authorship network for papers pub- lished in the InfoVis conference from 1995 to 2015 [1]. Authors collaborating on a paper are connected in a clique at the time of publication of the paper. Note this is not a cumulative network as authors can appear, disappear, and appear again. The data is of discrete nature with exactly 21 timeslices (one per year). Van De Bunt (Discrete): shows the relationships between 32 freshmen at seven different time points. A discrete dynamic graph is built using the method of Brandes et al. [9], with an undirected edge inserted into a timeslice if the participants reciprocally report "best friendship" or "friendship" at that time. Newcomb Fraternity Data (Discrete): contains the sociometric preference of 17 members of a fraternity in the University of Michigan in the fall of 1956 [39]. As in previous work [9], at each timeslice, we inserted undirected edges connect- ing students to their three best friends. Rugby (Continuous): is a network derived from over 3,000 tweets involving teams in the Guinness Pro12 rugby competition. The tweets were posted between 09.01.2014 and 10.23.2015. Each tweet contains information about the involved teams and the time of publication with a precision down to the second. Pride and Prejudice (Continuous): lists the dialogues between characters in the novel Pride and Prejudice in order [29]. The book has 61 chapters and the data set includes over 4,000 interactions between characters. 5.2 Method As there are no continuous dynamic graph drawing algorithms, we need to compare our results with discrete dynamic graph drawing algorithms. In our metric evaluation, we considered three drawing approaches: – Visone (v) drawings were computed using the discrete version (timesliced) with visone [10]. We use a linking strategy [9] with a default link length of 200 and a stability parameter α = 0.5. – Discrete (d) drawings were computed using a modified version of DynNoSlice on the discrete version. Each trajectory bend coincides with a timeslice and bends cannot be inserted or removed. The rest of the algorithm is unaltered. We used δ = 1 as the desired edge length parameter. – Continuous(c) drawings were computed using DynNoSlice. We used δ = 1 as the desired edge length parameter. We evaluate the results using a variety of metrics: – Stress: the average edge stress, as defined by Brandes and Mader [9, Formula 1]. As stress is defined for a static graph, we slice the space-time cube and average the stress computed on each timeslice. – Node Movement: the average 2D movements of the nodes. Intuitively, this is the average distance traveled by nodes when animating the dynamic graph. – Crowding: This metric counts the number of times nodes collide during the animation of the dynamic graph. – Running Time in seconds. For continuous dynamic graphs, we can compute the stress of the nodes and edges present in the timeslice defined by the discrete dynamic graph or on the node and edge set at that precise point in continuous time. We can also compute stress between timeslices. Thus, we consider four measures of stress: – StressOn(d): the stress computed on the timeslices using the node and edge set of that timeslice. – StressOff(d): the stress computed on and between the default timeslices using the node and edge set of the closest timeslice in time, when between two timeslices. – StressOn(c): the stress computed on the timeslices using the precise node and edge appearances in continuous time. – StressOff(c): the stress computed on and between the timeslices using the precise node and edge appearances in continuous time. Graph Scaling Uniformly scaling node positions changes the measure of stress even though the layout is the same [27, 33, 40]. In order to compare methods as fairly as possible, we used a strategy where scale-independent values of stress are compared as follows. Both visone and DynNoSlice have a parameter that indicates the desired edge length. First, we verified that visone produces the same result (up to scale) when changing the edge length parameter. Thus, we use the default value of edge length but consider different scaling factors to compare to the output of our algorithm. For the experiment, we defined nodes to be circles of diameter 0.2 and with an ideal edge length of 1. To obtain such drawing with our approach, we run the algorithm with an ideal edge length parameter δ = 1. To obtain such drawing with visone, we run it with the default edge length of 200 and scale it down by a factor 200. Related work in static graph drawing [27, 33, 40] searches for the best scaling factor via binary search, as a minimum is guaranteed. For our metric (average stress across all timeslices) we have no such guarantee. Thus, we evaluate scaling factors (1.1)i, with i ∈ Z : −20 < i < 20 for the best StressOn(d) value. This scaling factor is used to compute all metrics. After plotting the average stress for each data set, a minimum in this range was consistently observed. 5.3 Results Videos of Newcomb, Rugby, and Pride and Prejudice are provided in the supplementary material. In this section, we present our quantitative results. visone is often faster than our continuous approach as DynNoSlice operates on a greater volume of data – the data between timeslices. The discrete version of DynNoSlice is often slower than both, as the continuous approach is more naturally expressed without timeslices. Therefore, there is a penalty for imposing timeslices on it. Table 1 shows the results on the discrete data sets. Continuous stress metrics are not computed, because nodes and edges only appear on timeslices. In the VanDeBunt and Newcomb data sets, visone outperforms DynNoSlice in terms of stress. Movement and crowding are comparable among all three approaches. Graph Type Time (s) Scale StressOn (d) StressOff (d) Movement Crowding VanDeBunt Newcomb InfoVis v d c v d c v d c 0.13 7.73 6.73 0.11 9.68 7.62 77.43 388.38 381.15 1.00 0.62 0.68 1.00 0.68 0.75 0.47 0.56 0.56 1.14 1.20 1.19 14.04 16.61 18.13 51.66 31.09 32.70 1.46 1.20 1.29 14.77 16.59 17.98 52.98 31.04 34.02 3.80 3.91 3.69 16.36 13.48 12.37 2.15 2.03 1.91 0 0 0 8 2 0 36 8 6 Table 1: Results for the discrete data sets on our metrics. Our continuous approach is sometimes able to improve on visone when stress is computed off timeslices. When comparing the discrete and continuous versions of DynNoSlice, our discrete version is often able to optimize on-timeslice stress. InfoVis is an outlier for the timesliced data sets. In particular, our continuous approach outperforms visone in terms of stress. Table 2 shows the results of our metric experiment on the continuous data sets. Our continuous approach has lower off-timeslice stress, lower average move- ment, fewer crowding events, and occasionally lower on-timeslice stress. Graph Type Time (s) Scale StressOn (c) StressOff (c) Movement Crowding Rugby Pride v d c v d c 0.08 7.40 3.88 3.39 1655.50 75.61 0.68 0.68 0.51 0.18 0.32 0.24 3.08 1.84 1.84 0.62 0.82 0.83 2.71 1.71 1.77 0.88 0.86 0.85 25.47 16.23 6.57 5.44 6.95 1.12 6 1 0 682 13 3 Table 2: Results for the continuous data sets on our metrics. 5.4 Discussion Our results on the discrete data sets were expected: visone optimizes for stress directly on every timeslice and so outperforms our force system in terms of stress, while it is comparable in terms of movement and crowding. As a state- of-the-art algorithm for timesliced graph drawing, it is difficult to compete with visone when it is running on the type of data for which it was designed. However, when stress is measured off the timeslices, our continuous approach often out- performs visone. The timesliced model does not allow for stress to be optimized between timeslices and must resort to linear interpolation, leading to subopti- mal stress. In our continuous dynamic graph model, we optimize for stress in continuous time, leading to this performance improvement. The InfoVis data set is an exception where DynNoSlice is able to improve on visone in terms of stress. This result could be due to the bursty nature of this graph (edges are only present if two authors published a joint paper that year). Therefore, large parts of the graph change drastically from year to year. Allowing node trajectories to evolve independently of timeslices may allow DynNoSlice to perform better. For nearly all continuous data sets, our continuous model often outperforms visone in terms of stress, movement, and crowding. This is likely due to the fact we do not use timeslices to compute the layout of the dynamic graph. As a result, we are able to optimize stress between timeslices as well. On-timeslice stress is an exception, as it is directly optimized by visone. It is surprising that our continuous dynamic graph drawing algorithm simul- taneously improves node movement and crowding while remaining competitive or improving on stress. This finding may seem counter-intuitive as low stress usually corresponds to high node movement. This result can be explained by the fact that nodes in our continuous models are polylines of adaptive complexity in the space-time cube. Nodes with few interactions in the data will be long straight lines, potentially passing through many timeslices. These areas of low complexity will reduce average node movement. In a model that uses timeslices, each timeslice is forced to have that node with inter-timeslice edges. Therefore, timeslices impose additional node movement that may not be necessary. In terms of crowding, the continuous model allows the polyline representing a node to adapt its complexity between timelices if there are many interac- tions. When there are many changes to the graph in a short period of time, these polylines have increased complexity, allowing nodes to avoid crowding. In a timesliced model, only linear interpolation is possible, and all nodes must fol- low straight lines. Thus, crowding is incurred. Crowding is also avoided in our continuous model as our polylines have repulsive forces between them. In all timeslice approaches, inter-timeslice edges do not repel each other, potentially causing crowding events. 6 Conclusions and Future Work We presented a model for dynamic graph drawing without timeslices in which nodes and edges, along with their attributes, are defined on continuous time intervals. We developed a dynamic graph drawing algorithm, DynNoSlice, that visualizes graphs in this model by working on the space-time cube. An imple- mentation of this algorithm is available along with a video. In our evaluation, we demonstrate that our continuous approach has significant advantages over timeslicing the continuous data. The focus of this paper is a method to draw dynamic graphs without times- lices. An animation of a slice traversing the layout in the space-time cube is a natural visualization. However, animation is not always effective in terms of hu- man performance [4, 22, 48], especially when events are of short duration. More effective visual representations the layout present in the space-time cube are necessary. The primary issue that we have found with collapsing continuous time down onto a series of timeslices is that the timeslices could oversample/undersample the data in the continuous dimension. In signal processing, the Nyquist frequency gives the minimum sampling rate required to reconstruct the signal. Regular timeslices taken a the smallest temporal distance between two events should be sufficient to avoid undersampling, but lower sampling frequencies could be possible and remain future work. References 1. Citevis citation datafile. http://www.cc.gatech.edu/gvu/ii/citevis/ infovis-citation-data.txt. Accessed: 2017-08-28. 2. D. Archambault and H. C. Purchase. Mental map preservation helps user orien- tation in dynamic graphs. In W. Didimo and M. Patrignani, eds., Proc. of Graph Drawing (GD '12), vol. 7704 of LNCS, pp. 475–486, 2013. 3. D. Archambault and H. C. Purchase. Can animation support the visualization of dynamic graphs? Information Sciences, 330:495–509, 2016. 4. D. Archambault, H. C. Purchase, and B. Pinaud. Animation, small multiples, and the effect of mental map preservation in dynamic graphs. IEEE Trans. on Visualization and Computer Graphics, 17(4):539–552, 2011. 5. B. Bach, P. Dragicevic, D. Archambault, C. Hurter, and S. Carpendale. A descrip- tive framework for temporal data visualizations based on generalized space-time cubes. Computer Graphics Forum, 2016. 6. B. Bach, C. Shi, N. Heulot, T. Madhyastha, T. Grabowski, and P. Dragicevic. Time curves: Folding time to visualize patterns of temporal evolution in data. IEEE Trans. on Visualization and Computer Graphics (InfoVis '15), 22(1):559– 568, 2016. 7. F. Beck, M. Burch, S. Diehl, and D. Weiskopf. The state of the art in visualiz- ing dynamic graphs. In R. Borgo, R. Maciejewski, and I. Viola, eds., EuroVis - STARSs. The Eurographics Association, 2014. 8. U. Brandes and S. R. Corman. Visual unrolling of network evolution and the analysis of dynamic discourse. Information Visualization, 2(1):40–50, Mar. 2003. 9. U. Brandes and M. Mader. A quantitative comparison of stress-minimization ap- proaches for offline dynamic graph drawing. In M. van Kreveld and B. Speckmann, eds., Proc. of Graph Drawing (GD '11), vol. 7034 of LNCS, pp. 99–110, 2012. 10. U. Brandes and D. Wagner. Analysis and Visualization of Social Networks, pp. 321–340. Mathematics and Visualization. Springer Berlin Heidelberg, 2004. 11. I. Bruss and A. Frick. Fast interactive 3-D graph visualization. In F. J. Bran- denburg, ed., Proc. of Graph Drawing (GD '95), vol. 1027 of LNCS, pp. 99–110. Springer, 1996. 12. M. Burch, C. Vehlow, F. Beck, S. Diehl, and D. Weiskopf. Parallel edge splatting for scalable dynamic graph visualization. IEEE Trans. on Visualization and Computer Graphics (InfoVis '11), 17(12):2344–2353, 2011. 13. M. Cordeil, T. Dwyer, K. Klein, B. Laha, K. Marriott, and B. H. Thomas. Immer- sive collaborative analysis of network connectivity: CAVE-style or head-mounted display? IEEE Trans. on Visualization and Computer Graphics (InfoVis '16), 23(1):441–450, 2017. 14. T. Crnovrsanin, J. Chu, and K.-L. Ma. An incremental layout method for visual- izing online dynamic graphs. In E. D. Giacomo and A. Lubiw, eds., Proc. of the International Symposium on Graph Drawing and Network Visualization (GD '15), vol. 9411 of LNCS, pp. 16–29. Springer, 2015. 15. I. F. Cruz and J. P. Twarog. 3D graph drawing with simulated annealing. In F. J. Brandenburg, ed., Proc. of Graph Drawing (GD '95), vol. 1027 of LNCS, pp. 162–165. Springer, 1996. 16. R. Davidson and D. Harel. Drawing graphs nicely using simulated annealing. ACM Trans. on Graphics, 15(4):301–331, Oct. 1996. 17. S. Diehl and C. Gorg. Graphs, they are changing - dynamic graph drawing for a sequence of graphs. In M. T. Goodrich and S. G. Kobourov, eds., Proc. of Graph Drawing (GD' 02), vol. 2528 of LNCS, pp. 23–31. Springer, 2002. 18. S. Diehl, C. Gorg, and A. Kerren. Preserving the mental map using foresighted layout. In Eurographics/IEEE VGTC Symposium on Visualization (VisSym01), pp. 175–184, 2001. 19. T. Dwyer and P. Eades. Visualising a fund manager flow graph with columns and worms. In Proc. of the International Conference on Information Visualisation (IV '02), pp. 147–152, 2002. 20. C. Erten, P. J. Harding, S. G. Kobourov, K. Wampler, and G. Yee. GraphAEL: Graph animations with evolving layouts. In G. Liotta, ed., Proc. of Graph Drawing (GD '03), vol. 2912 of LNCS, pp. 98–110. Springer, 2004. 21. C. Erten, S. G. Kobourov, V. Le, and A. Navabi. Simultaneous graph drawing: Layout algorithms and visualization schemes. In G. Liotta, ed., Proc. of Graph Drawing (GD '03), vol. 2912, pp. 437–449. Springer, 2004. 22. M. Farrugia and A. Quigley. Effective temporal graph layout: A comparative study of animation versus static display methods. Journal of Information Visualization, 10(1):47–64, 2011. 23. D. Forrester, S. G. Kobourov, A. Navabi, K. Wampler, and G. Yee. Graphael: A system for generalized force-directed layouts. In J. Pach, ed., Proc. of Graph Drawing (GD '04), vol. 3383, pp. 454–464. Springer, 2005. 24. A. Frick, A. Ludwig, and H. Mehldau. A fast adaptive layout algorithm for undi- rected graphs. In R. Tamassia and I. G. Tollis, eds., Graph Drawing: DIMACS International Workshop (GD '94), vol. 894 of LNCS, pp. 388–403. Springer Berlin Heidelberg, 1995. 25. Y. Frishman and A. Tal. Online dynamic graph drawing. IEEE Trans. on Visual- ization and Computer Graphics, 14(4):727–740, July 2008. 26. P. Gajer and S. G. Kobourov. GRIP: Graph drawing with intelligent placement. In J. Marks, ed., Proc. of Graph Drawing (GD '00), vol. 1984 of LNCS, pp. 222–228. Springer, 2001. 27. E. R. Gansner, Y. Hu, and S. North. A maxent-stress model for graph layout. IEEE Trans. on Visualization and Computer Graphics, 19(6):927–940, 2013. 28. T. E. Gorochowski, M. Di Bernardo, and C. S. Grierson. Using aging to visually uncover evolutionary processes on networks. IEEE Trans. on Visualization and Computer Graphics, 18(8):1343–1352, Aug. 2012. 29. S. Grayson, K. Wade, G. Meaney, and D. Greene. Sensibility of different slid- ing windows in constructing co-occurrence networks from literature. In B. Bozic, G. Mendel-Gleason, C. Debruyne, and D. O'Sullivan, eds., Proc. 2nd Interna- tional Workshop on Computational History and Data-Driven Humanities, pp. 65– 77, 2016. 30. G. Groh, H. Hanstein, and W. Worndl. Interactively visualizing dynamic social In Workshop on Visual Interfaces to the Social and the networks with DySoN. Semantic Web (VISSW2009), Feb. 2009. 31. S. Hachul and M. Junger. Drawing large graphs with a potential-field-based mul- tilevel algorithm. In J. Pach, ed., Proc. of Graph Drawing (GD '04), vol. 3383, pp. 285–295. Springer, 2004. 32. M. Itoh, N. Yoshinaga, M. Toyoda, and M. Kitsuregawa. Analysis and visual- ization of temporal changes in bloggers' activities and interests. In IEEE Pacific Visualization Symposium (PacificVis '12), pp. 57–64, 2012. 33. S. G. Kobourov, S. Pupyrev, and B. Saket. Are crossings important for drawing large graphs? In C. Duncan and A. Symvonis, eds., International Symposium on Graph Drawing (GD '14), pp. 234–245. Springer Berlin Heidelberg, 2014. 34. B. Landgraf. 3D graph drawing. In M. Kaufmann and D. Wagner, eds., Drawing Graphs, vol. 2025 of Lecture Notes in Computer Science, pp. 172–192. Springer, Apr. 2001. 35. G. Liu, E. L. Austen, K. S. Booth, B. D. Fisher, R. Argue, M. I. Rempel, and J. T. Enns. Multiple-object tracking is based on scene, not retinal, coordinates. Journal of Experimental Psychology: Human Perception and Performance, 31(2):235–247, 2005. 36. Q. Liu, Y. Hu, L. Shi, X. Mu, Y. Zhang, and J. Tang. EgoNetCloud: Event-based egocentric dynamic network visualization. In Proc. of the IEEE Conference on Visual Analytics Science and Technology (VAST15), pp. 65–72. IEEE Computer Society, 2015. 37. K. Misue, P. Eades, W. Lai, and K. Sugiyama. Layout adjustment and the mental map. Journal of Visual Languages & Computing, 6(2):183–210, 1995. 38. T. Munzner. H3: Laying out large directed graphs in 3D hyperbolic space. In Proc. of the IEEE Symposium on Information Visualization (InfoVis '97), pp. 2– 10, 1997. 39. T. M. Newcomb. The Acquaintance Process. Holt, Reinhard & Winston, 1961. 40. M. Ortmann, M. Klimenta, and U. Brandes. A sparse stress model. In Y. Hu and M. Nollenburg, eds., Proc. of the International Symposium on Graph Drawing and Network Visualization (GD '16), pp. 18–32, 2016. 41. G. Parker, G. Franck, and C. Ware. Visualization of large nested graphs in 3D: Navigation and interaction. Journal of Visual Languages & Computing, 9(3):299– 317, June 1998. 42. Z. W. Pylyshyn and R. W. Storm. Tracking multiple independant targets: Evidence for a parallel tracking mechanism. Spatial Vision, 3(3):179–197, 1988. 43. P. E. Rauber, A. X. Falcao, and A. C. Telea. Visualizing time-dependent data using dynamic t-SNE. In E. Bertini, N. Elmqvist, and T. Wischgoll, eds., EuroVis 2016, Short Papers. Eurographics Association, 2016. 44. A. Sallaberry, C. Muelder, and K.-L. Ma. Clustering, visualizing, and navigating for large dynamic graphs. In W. Didimo and M. Patrignani, eds., Proc. of Graph Drawing (GD '12), vol. 7704, pp. 487–498. Springer, 2013. 45. B. Shneiderman and A. Aris. Network visualization by semantic substrates. IEEE Trans. on Visualization and Computer Graphics (InfoVis '06), 12(5):733–740, 2006. 46. P. Simonetto, D. Archambault, D. Auber, and R. Bourqui. ImPrEd: An improved force-directed algorithm that prevents nodes from crossing edges. Computer Graph- ics Forum (EuroVis '11), 30(3):1071–1080, 2011. 47. P. Simonetto, D. Archambault, and C. Scheidegger. A simple approach for bound- ary improvement of Euler diagrams. IEEE Trans. on Visualization and Computer Graphics (InfoVis '15), 22(1):678–687, 2016. 48. B. Tversky, J. Morrison, and M. Betrancourt. Animation: Can it facilitate? Inter- national Journal of Human-Computer Studies, 57(4):247–262, 2002. 49. S. van den Elzen, D. Holten, J. Blaas, and J. J. van Wijk. Dynamic network visualization with extended massive sequence views. IEEE Trans. on Visualization and Computer Graphics, 20(8):1087–1099, Aug. 2014. 50. S. van den Elzen, D. Holten, J. Blaas, and J. J. van Wijk. Reducing snapshots to points: A visual analytics approach to dynamic network exploration. IEEE Trans. on Visualization and Computer Graphics (VAST '15), 22(1):1–10, 2016.
1107.0681
1
1107
2011-07-04T17:05:18
Does Quantum Interference exist in Twitter?
[ "cs.SI", "cs.IT", "cs.IT", "physics.soc-ph" ]
It becomes more difficult to explain the social information transfer phenomena using the classic models based merely on Shannon Information Theory (SIT) and Classic Probability Theory (CPT), because the transfer process in the social world is rich of semantic and highly contextualized. This paper aims to use twitter data to explore whether the traditional models can interpret information transfer in social networks, and whether quantum-like phenomena can be spotted in social networks. Our main contributions are: (1) SIT and CPT fail to interpret the information transfer occurring in Twitter; and (2) Quantum interference exists in Twitter, and (3) a mathematical model is proposed to elucidate the spotted quantum phenomena.
cs.SI
cs
1 Does Quantum Interference exist in Twitter? Xin Shuai1∗, Ying Ding2, Jerome Busemeyer3, Yuyin Sun2, Shanshan Chen2, Jie Tang4 1 School of Informatics and Computing, Indiana University, Bloomington, IN, USA 2 School of Information and Library Science, Indiana University, Bloomington, IN, USA 3 Department of Psychological and Brain Sciences, Indiana University, Bloomington, IN, USA 4 Department of Computer Science and Technology, Tsinghua University, Beijing, China ∗ E-mail: Corresponding [email protected] Abstract It becomes more difficult to explain the social information transfer phenomena using the classic models based merely on Shannon Information Theory (SIT) and Classic Probability Theory (CPT), because the transfer process in the social world is rich of semantic and highly contextualized. This paper aims to use twitter data to explore whether the traditional models can interpret information transfer in social net- works, and whether quantum-like phenomena can be spotted in social networks. Our main contributions are: (1) SIT and CPT fail to interpret the information transfer occurring in Twitter; and (2) Quantum interference exists in Twitter, and (3) a mathematical model is proposed to elucidate the spotted quantum phenomena. Introduction Shannon Information Theory (SIT) [1] and Classic Probability Theory (CPT) quantify the information by encoding information as symbols and ignoring their semantic aspects. Such a strategy is very successful in capturing the essential structure and dynamics of information transfer, therefore becoming the backbone of the modern telecommunication and network transmission technology. As the Web2.0 increases in popularity, our current ways of communicating are changing dramatically. Facebook has become gathering spot in our daily lives by connecting like-minded folks and establishing virtual communities to solve problems and accomplish tasks. News and comments about natural disasters (e.g. Japans Tsunami) and political uprisings (e.g. Middle Easts antigovernment protests) travel with a lightning speed in Twitter. As a result, the focus of information transfer gradually move from its technological aspect to social aspect, where the semantic and human factor becomes so important that cannot be neglected. It becomes more and more difficult to explain the social information transfer phenomena using the classic models based merely on CPT and SIT, because the transfer process in the social world is highly contextualized. The influence of possible channels of flowing information in the complex and yet dynamic social networks is sophisticated enough that any classic probabilistic model might hardly satisfy. Many recent studies are devoted to social information transfer in different social networks [2 -- 5] and several interesting findings have been observed. However, none of them attempted to disclose the insufficiency of SIT and CPT to interpret some aspects of social information transfer or proposed a new model that that may better serve as a supplementation to the existing classic models. Recently Purdue University received $25 million funding from U.S. National Science Foundation to create the Science of Information Center to move beyond Shannon theory. They aim to develop principles to encompass concepts of structure, time, space, and semantics to aid better understanding of social networks and social media behaviors [6]. The information is no longer the 1s or 0s of binary code and its meaning can be contextually interpreted based on different temporal, spatial and semantic factors. The value of information can change dramatically over time and the flow of information can heavily depend on how people use and trust these channels. The Web is becoming more complicated and dynamic, currently there is no good way to measure how information is transferred and evolved on the Web. SIT only cares 2 about the physical essence of the information but ignore its semantic essence. It is time to rethink how information is diffused through social networks so that we can better understand the essential difference between social information transfer and physical information transfer. The origin of information transfer in social networks comes from social influence, which occurs when an individual's thoughts, feelings or actions are affected by other people. Information transfer characterizes the way that a node in social network can spread information to its neighbor nodes via exerting social influence to them. Consequently, those neighbor nodes can continually influence their own neighbor nodes to further spread that information. Given the complexity in social information transfer, some well-established conclusion in SIT and CPT may not hold any more. According to SIT, there is a default assumption in information transfer that all information transfer channels are independent and there are no interferences among them. However, this default assumption might be incorrect. For example, if a node in social network is influenced by two neighbor nodes, and tries to make decisions based on the information obtained from the two neighbors, it is natural for this node to consider the two neighbors together rather than think of them independently. In other words, the information transferred via the two neighbors might have an interference effect on each other. Such interference between different information channels is very similar to the interference between different light waves that has already been explained by Quantum Theory (QT) [7]. Grounded on a mathematical basis, QT bears the potential to model and calculate the contextual and semantic information associated with one entity, which takes into account not only the independent features of this entity but also the dependent features in different contexts and the interference of these dependent features. Whether quantum-like phenomena can be spotted in social networks is the question we hope to explore. To address it, we specifically studied the information transfer in Twitter and our main contributions include: • discovered the phenomenon that the amount of information transfer in Twitter NOT always monoton- ously increases along with number of channels, which is incompatible with some conclusions in SIT. • proposed a quantum version of q-attention model that is capable of mathematically interpreting the conflict between decreased information transfer and increased channels Methodology Information Transfer in Social Network In a social network, there're no clearly defined information source, channel and receiver, because each agent in the network is a node. According to different situations, each node can act as a source, or a channel or a receiver. Figure 1 shows different information transfer patterns: 1) one-channel information transfer pattern: A is the source while C is the receiver, and information flows from A to C via a channel created by an intermediate node B; 2) two-channel information transfer pattern: A is the source while C is the receiver, and information flows from A to C via two channels created by intermediate nodes B1 and B2, respectively; and 3) n-channel information transfer pattern: A is the source while C is the receiver, and information flows from A to C via a number of channels created by a list of intermediate nodes B1, B2,..., Bn. A simple research question can be specified as: How does the total amount of information transferred from A to C change with the increase/decrease of the number of available channels? Information transfer in Twitter Twitter users send and read messages called tweets. One user can follow other users and retweet their tweets. Such retweeting relationships connect Twitter users and form the social network where informa- tion is transfered via retweeting, as identified by RT @username in tweets. Assume A is a Twitter user 3 (a) (b) (c) Figure 1. Information transfer patterns who has two followers B1 and B2. B1 and B2 have some common followers and C is one of them. One tweet coming from user A can be retweeted by both B1 and B2. If B1 or B2 retweets A's tweets, their tweets contain RT @A. Here, we assume that C does not directly follow A and can only see A's tweets retweeted by B1 or B2. So, C can decide whether to further retweet A's tweets from B1 or B2. Those retweets posted by C contain the sign as: RT @B1 : @A or RT @B2 : @A which means that C retweets A's tweets via B1 or B2. Now we define the retweeting probability to measure the amount of information transferred from one user to another through retweeting, directly or indirectly. If A's tweets are retweeted by B, then the retweeting probability is the percentage of A's tweets retweeted by B. For example, if A posted 100 tweets and 20 of them are directly retweeted by B. Then, the retweeting probability of B from A is 20/100 = 0.2, marked as P(BA) = 0.2. Consider the situation where an intermediate node B exists between A and C (Figure 1(a)). If A posted 100 tweets and 20 of them are retweeted by B. Of the 20 retweets, 5 are further retweeted by C. Then the retweeting probability of C from A via B, is 5/100 = 0.05, marked as P(CA; B) = 0.05. Note that it is different from the case that C directly retweets A, in which no intermediate node B exists. If the number of channels between A and C increases to two(Figure 1(b)), we can define three retweet- ing probabilities: P(CA; B1) indicates the probability that A's tweets are retweeted by B1 and further retweeted by C as if B2 does not exist; P(CA; B2) indicates the probability that A's tweets are retweeted by B and further retweeted by C as if B2 does not exist; P(CA; B1, B2) indicates the probability that A's tweets are retweeted by either of B1 or B2, and further retweeted by C. In general, as is shown in Figure 1(c), we can define n separate retweeting probabilities (e.g., P(CA; B1), P(CA; B2), ..., P(CA; Bn)) and an overall retweeting probability, i.e. P(CA; B1, B2, ..., Bn). The rela- tionship between P(CA; B1, B2, ..., Bn) and n separate probabilities, i.e., P(CA; B1), ..., P(CA; Bn) is of our interest. A B C A B2 B1 C A B1 B2 C Bn 4 Q-attention Model To determine the relationship between retweeting probability and the number of channels, we proposed a q-attention model based on CPT by taking into account human cognition (Figure 2). The q-attention model originates from Batchelder's work [8] presenting a family of processing models for the source- monitoring paradigm in human memory, but is specifically modified to cater to our information transfer research in Twitter. The model is designed for the situation in which agent A posts a tweet that is received by a group of agents Bj, j = 1, 2, ...n, who may or may not choose to retweet it to agent C. There is no direct connection between A and C and the tweets from A can only reach C through one of the agents Bj. We examine this probability as a function of the number, denoted n, of agents Bj who both see A's tweets and retweet them to C. It is true that there is no universal way to build a classic model based on CPT and human cognition for information transfer and our q-attention model is just one of many possible models. We assume that agent C has some limits on capacity for the number of tweets that can be considered. Consequently agent C can only pay attention to a total number of N intermediate agents forming a total set T = {B1, B2, ...BN} . A subset of n ≤ N of these agents Sn = {B1, ..., Bn} ⊆ T receive A's tweets and also retweet them to C. In other words, C has total of N channels to receive message, but only n of them transfer tweets from A. N is a fixed number but n is a variable. Figure 2. q-attention model require (cid:80)N Define qj as the probability that agent C pays attention to the tweets from agent Bj ∈ T, and we j=1 qj = 1. The joint probability that agent Bj is selected for attention and then agent C decides to retweets from A passed along by Bj equals to qj · P(CA; Bj). Finally, for some set of agents Sn, the probability that agent C retweets from agent A through any one of the members in Sn is obtained from the sum of path probabilities and also known as the law of total probability in CPT: P (CA; Sn) = qj · P(CA; Bj). (1) For simplicity we use P(n) to represent P(CA; Sn). In order to calculate Equation 1, we need to know qj and P(CA; Bj), j = 1, 2, ...n. Actually qi are free parameters which can be hardly estimated from our data. N is the maximum number of channels C can pay attention to, which satisfy that (cid:88) Bj∈Sn P(N +k) = P(N ), k ∈ N+. We consider the initial values P(1) can be directly observed from the real data because the interference occurs only when n > 1. In addition, we assume that qi = 1−q1 N−1 , i = 2, 3, ..., n, and P(CA; Bj) = p for all channels. Finally, the q-attention model can be represented by a piecewise defined function: (cid:26)P(n) = P(1) + 1−q1 N−1 p · n, n = 2, 3, ..., N − 1 P(N + k) = P(N ), k ∈ N+ 5 (2) Now our task is to estimate the parameters of q-attention model in order to calculate P(n) in Equation 2. Before reaching to the plateau, P(n) is just a monotone increasing linear function, with positive slope 1−q1 N−1 p and through a fixed initial point P(1). Actually, it is very difficult to estimate q1, N and p from real data. Thus, instead of estimating those parameters separately, we will use linear regression approach based on least square principle through a fixed point P(1) to fit a linear curve based on data points from the real Twitter data. Then the curve can be used to predict P(n). It is important to note that according to this classic model, P(CA; Sn) increases monotonously with the variable n. In other words, adding more channels can never decrease the probability. Results We based our calculation on two tweets datasets using different crawling methods. One dataset is used to check the information transfer from a global scale, since the tweets come from public timelines. By contrast, the other dataset serves as a case study of information transfer from a local scale, since the tweets comes from an ego network. Dataset1 The first dataset contains 467 million tweets from 20 million public users for the time period from June to December 2009 1, which covers 20%-30% of total public tweets published on Twitter during that time frame. Only those tweets containing RT @username1: RT @username2 are selected. Then we grouped those tweets into different patterns based on the number of channels (See Figure 1). Figure 3 shows the distribution of the amount of information transfer patterns with different number of channels in dataset1. The distribution is skewed towards the information transfer patterns with relatively small number of channels. As the number of channels increases, the number of instances drops significantly. It implies that the occurrence of patterns with a large number of channels is relatively rare. The largest number of channels we found in our data is 29. However, we only selected one-channel through six-channel patterns to present our results, for two reasons: • The occurrence of patterns with a large number of channels is relatively rare. When the number of channels become very large, their results can be subject to random disturbance which yields unreliable observations. • The process of information transfer, described in q-attention model, consists of the linear increasing phase and the plateau phase. Only the increasing phase is relevant to the problem under study. The retweeting probability of an instance of n-channel pattern in Twitter data is calculated by: (cid:80) Bj∈Sn P(n) = 1http://snap.stanford.edu/data/#twitter N o. of tweets containing 'RT @Bj : RT @A(cid:48) N o. of tweets A posted (3) 6 Figure 3. No. of instances in different information transfer patterns in dataset1 To present the real retweeting probability for each transfer pattern, we take the average value of retweeting probabilities calculated from all instances belonging to that transfer pattern. And the q- attention model results are just the linear regression of the real retweeting probabilities of different patterns. Figure 4 compares the retweeting probability from the real data (noted as real value), with that from the q-attention model. Surprisingly, there are two drops in retweeting probability as the number of channels increases: a big one from 1 to 2, and a small one from 5 to 6. It is totally acceptable that the our q-attention model value cannot exactly match the real value because of the statistical errors. However, the observation that the amount of information occasionally decrease as the number of channels increase cannot be attributed to pure statistical errors, because it is contradictory to the one of the main conclusions in SIT, that increasing channels always increase the capacity of information being transferred. The results from dataset1 provide the global view about information transfer in Twitter, which q-attention model based on CPT cannot explain. Dataset2 The second dataset was crawled by members in Knowledge Engineering Lab at Tsinghua University. This dataset covered time frame from Aug. 1st to Dec. 12th, 2009. Crawling started from a specific user (@yanglicai, a relatively popular user in Chinese Twitter community) of Twitter, and algorithm was designed to check all his contacts involved in replies and retweets, who were not necessarily his followers or followees. Crawling proceeds in a breadth-first approach and results in 192,999 tweets from 8,254 users, and 25.5% of all tweets collected are retweeting messages. We can view dataset2 as an ego network with @yanglicai in the center and all other nodes having interactions with @yanglicai. Figure 5 shows that the average number of records in dataset2 is much smaller than dataset1, because the tweets in dataset2 come from a special ego social network. The largest number of channels we found in dataset2 is 21 and we also selected one-channel to six-channel for analysis. In Figure 6, the difference of retweeting probability between the real data (noted as the real value), and the q-attention model is shown. Similar to dataset1, two drops are spotted: from pattern1 to pattern2, from pattern4 to pattern5. 051015202530The No. of Channels0500000100000015000002000000250000030000003500000The No. of Instances 7 Figure 4. Comparison between real value and classic model in dataset1 Figure 5. No. of instances in different information transfer patterns in dataset2 The results from dataset2 provide the local scale about information transfer in Twitter, which further confirm the contradictory phenomenon in information transfer as we saw in dataset1 from the global scale. Based on the results from the above two datasets, we found that the amount of information transfer drops occasionally even though the number of information transfer channels increases. It is contradictory 123456The No. of Channels0.0210.0220.0230.0240.0250.0260.0270.0280.029Average Retweeting Probabilityreal valueq-attention model value0510152025The No. of Channels01000020000300004000050000The No. of Instances 8 Figure 6. Comparison between real value and classic model in dataset2 to SIT and CPT, which assumes that the increase of channels never decrease the information transfer. Someone may challenge our observation since the q-attention model is only one of many approaches to model information transfer and we take several assumptions to further simplify our model into a lineal function. Admittedly, using different classic model may yield different results. However, as long as the model is built on the law of total probability from CPT, the result will be consistent with the conclusion that increasing channels never decrease the information transfer amount proved in SIT. Therefore, the contradictory phenomenon we found in Twitter data is independent of which model we use. Discussion The main deficit of our proposed q-attention model lies in the assumption that the n information transfer channels are independent. However, such assumption tends to be counter intuitive. Let's see a concrete example. Assuming that C is a teacher and A is his student. C wants to write a personal evaluation about A and hope to know after-school behaviors about A. First, C obtains some of A's information via one of A's classmates B1. Then, in order to know more about A, C decides to inquiry A's another classmate B2. Assuming that the amount of information C gets from A through each single channel, i.e. from B1 or B2, is the same, can we definitely claim that C obtains more information about A after inquiring B2? Not necessary. For example, if C asks B1 whether A has a sister and B1 says yes, then C tends to judge A has a sister. However, if C asks B2 the same question but B2 says no, then how could C make his judgement? As a result, C may be confused and won't know whether A has a sister or not. In this case, for C, the information about A actually decreased when the number of information channels increases from one to two. The reason is that the information provided by two channels is not independent but have mutual interference in semantic. Moreover, such interference not only exist in the semantic aspect but also in the contextual aspect. Specifically, who provides the information, as well as when and where that information is provided, all contribute to the interference effect. QT provides an approach to model such complex inference which beyond the scope of SIT and CPT that only consider the quantity of information 123456The No. of Channels0.00300.00350.00400.00450.00500.00550.0060Average Retweeting Probabilityreal valueq-attention model value 9 but ignore its semantic and contextual aspects. Next we will introduce the quantum interference phenomenon in a physics experiment and how we can make an analogy between quantum interferences in physics and in information transfer. Then we will propose a quantum version of q-attention model to mathematically interpret the conflict between the increased number of channels and decreased amount of information transfer. From Double-slit Experiment to Information Transfer Quantum interference was first observed in a double-slit experiment by Thomas Young in 1803 [7]. Small quantum particles or waves pass through two slits interfered with each other and generated a pattern of bright and dark bands. The beams emerging from the two slits are coherent as they come from the same source (Figure 7). Figure 7. The double-slit experiment Now we introduce the social information transfer in the context of double slit experiment in Figure 7. Image that particles are shot from the lamp towards the two slits S1 and S2. Once the particle passes through S1 or S2, they hit the detector panel, positioned behind the screen, in a particular location x with probability PS1S2 (x). By closing slit S2, it is possible to measure the probability of particles being detected in position x passing through S1, namely PS1 (x). Similarly, by closing just slit S1, we can measure PS2(x). Based on CPT, we would expect that the probability particles being detected at x when both slits are open is the sum of the probability of passing through A and being detected at x, PS1(x), and the probability of passing through B and hitting the detector panel in x, PS2 (x). Let's make an analogy between particle shooting and information transfer defined in SIT. The lamp is equivalent to information source, the particles are equivalent information, the two slits are equivalent to two information channels, and the position x in the screen is equivalent to information receiver. The amount of information transferred from the source to x is measured by probability. According to SIT, the total capacity of information transfer is the sum of capacity of each channel, i.e. PS1S2 (x) = PS1 (x) + PS2 (x). Although the information is actually measured by bit in SIT, the law of total probability still holds. If a third slit S3 is open and particles can also reach x in the panel through it. To measure PS3(x), we need to close both S1 and S2. As a result, the total information transferred will be PS1S2S3 (x) = PS1 (x) + PS2 (x) + PS3(x). We defined a function Pn(x) representing the information transfer probability with the number of channels. Obviously, Pn(x) is a monotone increase function. However, there should 10 exist a upper limit upon the total amount of information transfer, because not all slits on the wall can let particles pass through and reach position x. Similarly, any real information receiver is subject to some receiving limit that increasing the information channel cannot further increasing the information amount as long as the limit is reached. In the q-attention model, such limit is considered as human's capacity of paying attention to a finite number of channels. As we mentioned above, the monotonous increase property of Pn(x) is built on CPT and confirmed in SIT. However, the double-slit experiment demonstrates the existence of quantum interference effect. In other words, PS1S2 (x) (cid:54)= PS1(x) + PS2(x). In particular, PS1S2(x) can be zero even though PS1(x) > 0 and PS2 (x) > 0. Now let's see how quantum-like interference may possibly occur in social information transfer. In Figure 1(a), the information is transferred from source A to receiver C via one channel connecting through B. There can be no quantum interference effect since only one information channel exists. C has no other alternative channel to obtain A's information except for B. However, when there is more than one channel, interference among these channels becomes possible. For example, in Figure 1(b), C can obtain information about A from either B1 or B2. According to SIT, path A -- B1 -- C and A -- B2 -- C are independent. In other words, the amount of information C obtained from A, is just the sum of amount of information form A to B1 to C as if B2 does not exist, and that of from A to B2 to C as if B1 does not exist. Because it assumes that B1 and B2 are totally unrelated from C's perspective. This is also consistent with SIT: more channels always tend to provide more information and therefore reduce uncertainty (entropy) about an event. However, we believe it is oversimplified in social network because the semantic of information are neglected. Assuming that the information content from B1 and B2 are contradictory, then C's uncertainty about A will only increase instead of decreasing. In other words, the total information transferred from A to C actually decreases according to C's cognition, when more channels are available. Here the quantum interference takes effect, because C tends to compare the information from different channel and make decisions. In addition, by considering the context of information channels, C is more likely to trust the channel which exerts more social influence upon him. In essence, the SIT only focuses on the quantity of information being transferred but ignore its semantic and contextual perspectives. Quantum Q-attention Model Since the q-attention model based on CPT cannot interpret the conflicts between increasing channel and decreasing information transfer, now we formulate a quantum version of the q-attention model, by taking into account the possible interference between channels. According to the probability defined in QT [9], a probability p of an outcome is not primitive but derived from something more primitive called a probability amplitude ψ (a complex number) -- the probability is obtained by squaring the magnitude of the amplitude, p = ψ2. There are three differences between the quantum q-attention model and the classic version. The first difference is that the classic probability of paying attention to agent Bj, previously denoted qj, is replaced by a probability amplitude denoted ψj. The agent C is assumed to be in a superposition state, denoted by N(cid:88) Sn(cid:105) = ψj · Bj(cid:105), (4) j=1 which represents this agent's potential to consider any one of the tweets from agents Bj in T, especially including the tweets posted from agent A passed along by the agents Bj in T. The probability amplitude ψj represents the 'potential' to consider the tweets of agent Bj, but this potential is represented by a complex number; the probability of paying attention to the tweets of agent Bj is obtained from the squared magnitude qj = ψj2 and again we require(cid:80)N j=1 ψj2 = 1. The second difference is that the classic probability that C retweets the from A through Bj, previ- ously denoted P(CA; Bj) is replaced by the probability amplitude (cid:104)CA; Bj(cid:105). The probability amplitude (cid:104)CA; Bj(cid:105) represents the 'potential' to retweet, but this potential is represented by a complex number; the probability of retweeting is obtained from the squared magnitude P(CA; Bj) = (cid:104)CA; Bj(cid:105)2 and once again we require P(CA; Bj) + P( ¯CA; Bj) = 1. The third difference is that QT obeys the law of total amplitude rather than the law of total probability from CPT. We define (cid:104)CSn(cid:105) as the probability amplitude that the agent C retweets the message from A by considering tweets from agents Bj in T. The probability that agent C retweets from agent A passed along by agents Bj in Sn then equals P(CA; Sn) = (cid:104)CA; Sn(cid:105)2 . According to QT, to determine the amplitude (cid:104)CA; Sn(cid:105), we replace the sum of path probabilities shown in Equation 1 with the sum of path amplitudes given below (cid:104)CA; Sn(cid:105) = ψj · (cid:104)CA; Bj(cid:105). 11 (5) (cid:88) Bj∈Sn Predictions for n=1,2,3 Let us see some examples of how our q-attention model encompass the interference effect. First consider n = 1 in which case there is only one agent S1 = {B1} . Then in this case P(1) = ψ1 · (cid:104)CA; B1(cid:105)2 = ψ12 · (cid:104)CA; B1(cid:105)2 . The probability that C retrweets A through this one agent is virtually the same as the classic version and no quantum interference occurs in this case. Next consider n = 2 in which case there are two agents S2 = {B1, B2} . In this case Equation 5 produces P(2) = ψ1 · (cid:104)CA; B1(cid:105) + ψ2 · (cid:104)CA; B2(cid:105)2 = ψ1 · (cid:104)CA; B1(cid:105)2 + ψ2 · (cid:104)CA; B2(cid:105)2 1 · ψ2) · (cid:104)CA; B1(cid:105)∗ · (cid:104)CA; B2(cid:105) 2) · (cid:104)CA; B1(cid:105) · (cid:104)CA; B2(cid:105)∗. + (ψ∗ + (ψ1 · ψ∗ The first two terms correspond to the same probabilities that one would obtain from the classic model. The last two terms form a conjugate pair, (ψ∗ (ψ1 · ψ∗ 1 · ψ2) · (cid:104)CA; B1(cid:105)∗ · (cid:104)CA; B2(cid:105) = ψ1 · ψ2 · (cid:104)CA; B1(cid:105) · (cid:104)CA; B2(cid:105) · (cos (θ12) + i · sin (θ12)) 2) · (cid:104)CA; B1(cid:105) · (cid:104)CA; B2(cid:105)∗ = ψ1 · ψ2 · (cid:104)CA; B1(cid:105) · (cid:104)CA; B2(cid:105) · (cos (θ12) − i · sin (θ12)) , where θ12 is the phase of each complex number which depends on the pair of agents {B1, B2} . The sum of this conjugate pair produces a real number called the interference term: Int12 = 2 · ψ1 · ψ2 · (cid:104)CA; B1(cid:105) · (cid:104)CA; B2(cid:105) · cos (θ12) . The cosine term can be positive (producing constructive interference), negative (producing destructive interference), or zero (producing no interference). If the cosine is sufficiently negative, then the probability of C indirectly retweets from A when given two paths can be smaller than the probability given a single path. This happens whenever ψ2 · (cid:104)CA; B2(cid:105)2 + Int < 0. When there is no interference, cos (θ12) = 0, then the probability that C retweets from A based on two intermediate agents must be larger than the probability based on a single agent. This follows the fact that when there is no interference, the probabilities from each path sum and exceed the single path just like the classic probability model. Now consider the case with n = 3 and S3 = {B1, B2, B3} . In this case we obtain P(3) = ψ1 · (cid:104)CA; B1(cid:105) + ψ2 · (cid:104)CA; B2(cid:105) + ψ3 · (cid:104)CA; B3(cid:105)2 = ψ1 · (cid:104)CA; B1(cid:105)2 + ψ2 · (cid:104)CA; B2(cid:105)2 + ψ3 · (cid:104)CA; B3(cid:105)2 +Int12 + Int13 + Int23, 12 with the interference defined as Intij = 2 · ψi · ψj · (cid:104)CA; Bi(cid:105) · (cid:104)CA; Bj(cid:105) · cos (θij) . Each pair of cosines can be positive or negative. If they are all negative, then we could find a decrease in probability for three paths as compared to two paths or one path. But if the cosines flip from positive to negative, they could cancel out in the sum leaving the result with no overall interference. In general, as more path amplitudes are added together there is a tendency for the interference terms to change sign and cancel out, which is called decoherence. When decoherence occurs, the quantum model starts behaving like the classic model. Related Work QT has been applied in information retrieval [10]. Furthermore, research demonstrates that quantum-like phenomena exist in human natural language, cognition and decision making [11, 12]. For example, the term bat can be modeled in a two dimensional vector space as a vector representing a linear combination of two senses: sports and animal. The same goes for the term boxer: sports and animal. Then the combination of boxer bat follows the quantum formalism [11]. Experiments show that many conceCPT combinations are non-separable meaning that the combination cannot be modeled by probability distributions across the senses of the individual words. The non-linear or non-separable combination of two entities exists not only in information retrieval but also other fields which deal with social interaction and cognitive interference. Phenomena containing interference cannot be modeled via classical probabilistic models. QT offers a probabilistic, logic and geometric formalism based on the mathematics of Hilbert spaces to describe the behavior of interference. Van Rijsbergen [13] provided a mechanism to describe logic-based IR models within a quantum for- malism, in particular with Hilbert spaces. One of the well-adopted is Logical Imaging (LI) [14]. LI calculates a probability that a document is relevant to a query by considering the correlation of terms that appears across different documents. Huertas-Rosero, Azzopardi, and van Rijsbergen [15] proposed quantum-based measures for documents by using the selective erasers. Erasers model the relation of one term with respect to another by using co-occurrence methods, and the distance between this term and other neighboring occurrences. Arafat and van Rijsbergen [10] applied QT to address some fundamental issues in search, which investigate and model user cognition and their interactions during the search process. Di Buccio, Lalmas, and Melucci [16] proposed a uniform way to model properties of entities, relationships of entities, and properties of relationships through a geometric framework in terms of vector subspaces [17]. Zuccon, Azzopardi and van Rijsbergen [15] proposed to represent documents and queries as subspaces rather than as vectors in traditional vector-space model. Then the relevance between the document and user query can be reformulated as how to distinguish preparations of different quantum systems, which can be measured using subspace distance. Hou and Song [18] proposed an extended vector space model (EVSM) to model context-sensitive high-order information. Zuccon, Azzopardi, and van Rijsbergen [15] suggest to rank the document relevance using QT as judgment of relevant is not independent from other documents, and the interference of other documents play an important role to judge the relevance. They proposed a novel quantum probability ranking principle (QPRP) to model situations that a document relevance assessment is influenced by other documents. Interference exists in document relevance judgment, especially when users change their relevance measurement for one doc- ument after they have measured other documents. Zhang et al. [19] proposed to use quantum finite automation (QFA) to represent the transition of the measurement states (the relevance degrees of the document judged by users) and dynamically model the cognitive interference of users when they are influenced by other related documents. Piwowarski, Frommholz, Lalmas, and van Rijsbergen [20] applied tensor products from QT to refine the representation of queries (as density operators) and documents (as 13 subspaces). Although QT has been extensively applied to IR and human cognition modeling, but none have apply QT to explain the information transfer in social networks, such as Twitter. Conclusion and Future Work In this paper, we studied whether quantum-like phenomena can be spotted in social networks. To address it, we constructed two social networks formed by the retweeting relationship in Twitter, proposed a CPT based q-attention model to quantify the information transfer by retweeting probability, and compared the model results with the real value. We found that CPT and SIT cannot interpret the conflict between decreased information transfer and increased channels and proposed a quantum version of q-attention model to solve the conflict. Although QT provides some promising potential to add semantic and context to classic information transfer, a great deal of future work remains. First, we should select more social network datasets, like Facebook, Myspace, or Blogs, to test the quantum-like phenomenon. Second, the quantum model we proposed only gives the theoretical possibility to explain the quantum-like interference, but does not provide empirical interpretation of what the interference are. We may need to apply the social influence theory to further explain it. Third, some psychological experiments can be conducted to better understand the quantum-like phenomenon. References 1. Shannon C (1849) A mathematical theory of communication. Bell System Technical Journal 27: 379 -- 423. 2. Cha M, Mislove A, Gummadi KP (2009) A measurement-driven analysis of information propagation in the flickr social network. In: International World Wide Web Conference (WWW). Spain. 3. Galuba W, Aberer K, Chakraborty D, Despotovic Z, Kellerer W (2010) Outtweeting the twit- tererspredicting information cascades in microblogs. In: 3rd Worshop on Online Social Network. Boston. 4. Kempe D, Kleinberg J, Tardos E (2003) Maximizing the spread of influence through a social network. In: SIGKDD. Washington DC. 5. Sadikov E, Medina M, Leskovec J, Molina HG (2011) Correcting for missing data in information cascades. In: WSDM11. Hong Kong. 6. Savage N (2011) Information theory after shannon. Communications of the ACM 54: 16 -- 18. 7. Young T (1804) The bakerian lecture: Experiments and calculations relative to physical optics. Philosophical Transactions of the Royal Society of London 94: 1 -- 16. 8. Batchelder WH, Riefer DM (1990) Multinomial processing models of source monitoring. Psycho- logical Review 97: 548 -- 564. 9. Gudder S (1988) Quantum Probability. Academic Pr. 10. Arafat S, van Rijsbergen C J (2007) Quantum theory and the nature of search. In: AAAI Sympo- sium on Quantum Interaction. California, pp. 114 -- 221. 11. Bruzaa P, Kittoa K, Nelsonb D, McEvoyc C (2009) Is there something quantum-like about the human mental lexicon? Journal of Mathematical Psychology 53: 362 -- 377. 14 12. Bruza PD, Kitto K, Ramm B, Sitbon L (2011) Quantum-like non-separability of concept combi- nations, emergent associates and abduction. Logic Journal of the IGPL 19. 13. van Rijsbergen CJ (2004) The Geometry of Information Retrieval. New York: Cambridge Univer- sity Press. 14. Zuccon G, Azzopardi LA, van Rijsbergen CJ (2008) A formalization of logical imaging for infor- mation retrieval using quantum theory. In: DEXA '08 Proceedings of the 2008 19th International Conference on Database and Expert Systems Application. Washington DC. 15. Zuccon G, Azzopardi L, Rijsbergen CV (2009) Semantic spaces: measuring the distance between In: QI '09 Proceedings of the 3rd International Symposium on Quantum different subspaces. Interaction. Berlin, pp. 225 -- 236. 16. Buccio ED, Lalmas M, Melucci M (2010) From entities to geometry: Towards exploiting multiple sources to predict relevance. In: Proceedings of the 1st Italian Information Retrieval Workshop (IIR10). Italy. 17. Melucci M (2008) A basis for information retrieval in context. ACM Transactions on Information Systems (TOIS) 26. 18. Hou Y, Song D (2009) Characterizing pure high-order entanglements in lexical semantic spaces via information geometry. In: QI'09. pp. 237 -- 250. 19. Zhang P, Song D, Hou Y, Wang J, Bruza P (2010) What can quantum theory bring to information In: AAAI-Fall 2010 Symposium on Quantum Informatics for Cognitive, Social, and retrieval. Semantic Processes. Washington DC. 20. Piwowarski B, Frommholz I, Lalmas M, van Rijsbergen K (2010) Automata modeling for cognitive interference in users' relevance judgment. In: CIKM '10 Proceedings of the 19th ACM international conference on Information and knowledge management. New York.
1511.01868
1
1511
2015-11-05T19:46:29
A Survey of Link Recommendation for Social Networks: Methods, Theoretical Foundations, and Future Research Directions
[ "cs.SI", "physics.soc-ph" ]
Link recommendation has attracted significant attentions from both industry practitioners and academic researchers. In industry, link recommendation has become a standard and most important feature in online social networks, prominent examples of which include "People You May Know" on LinkedIn and "You May Know" on Google+. In academia, link recommendation has been and remains a highly active research area. This paper surveys state-of-the-art link recommendation methods, which can be broadly categorized into learning-based methods and proximity-based methods. We further identify social and economic theories, such as social interaction theory, that underlie these methods and explain from a theoretical perspective why a link recommendation method works. Finally, we propose to extend link recommendation research in several directions that include utility-based link recommendation, diversity of link recommendation, link recommendation from incomplete data, and experimental study of link recommendation.
cs.SI
cs
A Survey of Link Recommendation for Social Networks: Methods, Theoretical Foundations, and Future Research Directions Zhepeng Li, Department of Operations and Information Systems York University zli@ schulich.yorku.ca Xiao Fang* Department of Management Information Systems University of Delaware [email protected] Olivia Sheng Department of Operations and Information Systems University of Utah [email protected] *Send comments to [email protected] A Survey of Link Recommendation for Social Networks: Methods, Theoretical Foundations, and Future Research Directions ABSTRACT Link recommendation has attracted significant attentions from both industry practitioners and academic researchers. In industry, link recommendation has become a standard and most important feature in online social networks, prominent examples of which include “People You May Know” on LinkedIn and “You May Know” on Google+. In academia, link recommendation has been and remains a highly active research area. This paper surveys state-of-the-art link recommendation methods, which can be broadly categorized into learning-based methods and proximity-based methods. We further identify social and economic theories, such as social interaction theory, that underlie these methods and explain from a theoretical perspective why a link recommendation method works. Finally, we propose to extend link recommendation research in several directions that include utility-based link recommendation, diversity of link recommendation, link recommendation from incomplete data, and experimental study of link recommendation. Keywords: Link Recommendation, Link Prediction, Social Network, Network Formation 1. Introduction A social network can be represented as 𝐺 =< 𝑉, 𝐸 >, where 𝑉 denotes the set of social entities in the network and 𝐸 represents the set of existing links each of which connects a pair of social entities. For example, a social network on Facebook consists of a set of users (i.e., social entities) connected by pairwise friendship links among them. Let 𝐸 be the set of potential links that have not been established in a social network; i.e., 𝐸 = 𝑉 × 𝑉 − 𝐸. We use 𝐹(𝑒) to denote the value of a potential link 𝑒 ∈ 𝐸. The link recommendation problem is to estimate the value of each potential link, rank potential links in decreasing order of value, and recommend top-ranked potential links. Link recommendation has attracted significant attentions from both industry practitioners and academic researchers over the years. In industry, link recommendation has become a standard and most important feature in online social networks since its early success at LinkedIn (Davenport and Patil 2012). 1 Prominent examples of link recommendation include “People You May Know” on Facebook and LinkedIn as well as “You May Know” on Google+. In academia, link recommendation has been and remains a highly active research area. Given the tremendous academic and practical interests in link recommendation, there is a need for a review of the state-of-the-art knowledge in this area as well as the identification of significant and interesting questions for future research. This survey aims to address this need. Our survey differs from prior surveys of link prediction for social networks (Hasan and Zaki 2011, Lü and Zhou 2011) and contributes to the literature in the following ways: (i) While prior surveys focus primarily on either learning-based link recommendation methods (Hasan and Zaki 2011) or proximity-based link recommendation methods (Lü and Zhou 2011), this survey reviews representative methods in both categories and is more comprehensive. (ii) Prior surveys have not examined social and economic theories underlying link recommendation methods. Our survey identifies these theories (e.g., social interaction theory) and explains from a theoretical perspective why a link recommendation method works. (iii) Our survey suggests a unique set of research directions worthy of future exploration. In general, existing link recommendation methods operationalize 𝐹(𝑒) as the likelihood that potential link 𝑒 will be established in the future and recommend the links that are most likely to be established (Kashima and Abe 2006, Hasan et al. 2006, Liben-Nowell and Kleinberg 2007, Yin et al. 2010, Backstrom and Leskovec 2011, Gong et al. 2012, Xia et al. 2012). Therefore, the core of these methods is the prediction of linkage likelihood. According to different prediction approaches used, existing link recommendation methods can be broadly categorized into learning-based methods and proximity-based methods, which we review in Sections 2 and 3 respectively. We summarize link recommendation methods in Section 4. We then identify social and economic theories underlying link recommendation methods in Section 5 and suggest important future research directions in Section 6. Section 7 concludes the paper. 2 2. Learning-based Methods Learning-based methods learn a model from training data constructed from observed link establishments and use the learned model to predict the linkage likelihood for each potential link. A model can be learned using classification approaches, probabilistic models, or relational learning approaches. Learning-based methods can thus be categorized as classification-based methods, probabilistic model-based methods, and relational learning-based methods. 2.1 Classification-based Methods Given a social network, we can construct training data from observed link establishments in the network. In general, each record of the training data has the format < 𝑓1, 𝑓2, … , 𝑓𝑚, 𝑙 >, where 𝑓1, 𝑓2, … , 𝑓𝑚 represent features that affect link establishments in the network and l is the class label. The class label 𝑙 is 1 for an existing link and it is 0 for a potential link. Commonly used features include topological features that are derived from the structure of a social network and nodal features that are computed from intrinsic characteristics of individual social entities. Topological features include neighbor-based features and path-based features. Neighbor-based features characterize neighborhoods of social entities, e.g., the number of common neighbors between social entities (Hasan et al. 2006, Lichtenwalter et al. 2010, Benchettara et al. 2010), while path-based features describe paths connecting social entities in a social network, e.g., the shortest distance between social entities (Hasan et al. 2006, Lichtenwalter et al. 2010, O'Madadhain et al. 2005, Benchettara et al. 2010, Wang et al. 2007). Nodal features can be computed from intrinsic characteristics of social entities, including demographic characteristics (Zheleva et al. 2008), geographic characteristics (O'Madadhain et al. 2005, Scellato et al. 2011, Wang et al. 2011), and semantic characteristics (Hasan et al. 2006, Wang et al. 2007). Typical classification approaches can be applied to the constructed training data to predict the linkage likelihood of a potential link. O'Madadhain et al. (2005) employ logistic regression to predict the likelihood of interactions between social entities using data regarding CiteSeer articles, AT&T telephone calls, and Enron emails. Wang et al. (2007) combine a local Markov random field model and logistic 3 regression to predict the likelihood of co-authorship using DBLP and PubMed article datasets. Benchettara et al. (2010) also predict the likelihood of co-authorship but employ a decision tree classifier enhanced with Adaboost for making the prediction. Gong et al. (2012) predict new and missing links in Google+ using support vector machine (SVM). Comparing popular classification approaches for predicting linkage likelihood, including Naïve Bayes, decision tree, SVM, and k-nearest neighbor, Hasan et al. (2006) find that SVM seems to be the most effective among these approaches and that SVM with a radial basis function (RBF) kernel outperforms SVM with a linear kernel. The performance of classification-based methods can be enhanced in a number of ways. One way to enhance the effectiveness and efficiency of these methods is through judicious selection of relevant features. In this vein, Xu and Rockmore (2012) and Bliss et al. (2014) design feature selection frameworks for ranking and weighting features. In addition, Lichtenwalter et al. (2010) suggest that the performance of classification-based methods can be improved by carefully sampling training data. According to Lichtenwalter et al. (2010), to predict the likelihood of linkage between social entities that are n hops away, it is more effective and efficient to use a training sample of entities that are n hops apart than to use the entire training data. Yet another way to enhance performance is to enrich a social network with additional information that is useful for linkage likelihood prediction. A social network can be enriched by incorporating additional relationships among its social entities. For example, Zheleva et al. (2008) enrich a friendship social network of pets with their family affiliations. A social network can also be enriched by adding additional nodes. For instance, Gong et al. (2012) propose a social-attribute network whose nodes consist of both social entities and attributes of these entities. Finally, traditional ways of improving the performance of classification approaches are beneficial too. For example, ensemble methods, such as AdaBoost and Bagging, have been employed to improve the performance of linkage likelihood prediction (Benchettara et al. 2010, Hasan et al. 2006, Lichtenwalter et al. 2010), and Doppa et al. (2010) develop a cost-sensitive method to address the class imbalance issue in linkage likelihood prediction. 4 2.2 Probabilistic Model-based Methods In general, probabilistic model-based methods (Kashima and Abe 2006, Clauset et al. 2008, Lu et al. 2010, Backstrom and Leskovec 2011, Hopcroft et al. 2011, Yang et al. 2011, Kim and Leskovec 2011, Barbieri et al. 2014, Dong et al. 2015, Song et al. 2015) predict the linkage likelihood 𝐿𝑖𝑗 between social entities 𝑣𝑖 and 𝑣𝑗 as 𝐿𝑖𝑗 = 𝑔(𝒇𝑖𝑗, 𝜽∗), (1) where 𝑔(⋅) is a prediction function, 𝒇𝑖𝑗 is a vector of features gathered from social entities 𝑣𝑖 and 𝑣𝑗, and 𝜽∗ is a vector of parameters that can be learned from observed link establishments. Given training data 𝐷 constructed from observed link establishments, 𝜽∗ is estimated as the parameter vector that best explains D – that is, 𝜽∗ = argmax 𝑂𝑏𝑗(𝐷𝑀, 𝜽), 𝜽 (2) where the objective function 𝑂𝑏𝑗(𝐷𝑀, 𝜽) defines how well observed link establishments can be explained by a probabilistic model M with a parameter vector 𝜽. We next discuss representative probabilistic model-based methods. The method proposed by Kashima and Abe (2006) is based on the intuition that a social entity’s linkage decision is influenced by his or her neighbors in a social network. Accordingly, they predict the linkage likelihood 𝜙𝑖𝑗 𝑡+1 between social entities 𝑣𝑖 and 𝑣𝑗 at time 𝑡 + 1 as 𝑡+1 = 𝜙𝑖𝑗 1 𝑉 − 1 ( ∑ 𝜃𝑘𝑗𝜙𝑘𝑖 𝑡 𝑡 + 𝜃𝑘𝑖𝜙𝑘𝑗 ) + (1 − 𝑘≠𝑖,𝑗 1 𝑉 − 1 ∑ 𝜃𝑘𝑗 + 𝜃𝑘𝑖 𝑘≠𝑖,𝑗 𝑡 , ) 𝜙𝑖𝑗 (3) where V is the set of social entities in a social network, entity k is a neighbor of entity i or j, parameter vector 𝜽 =< 𝜃𝑥𝑦∀𝑥, 𝑦 ∈ 𝑉 >. The stationary likelihood of linkage between a pair of social entities is obtained by iteratively updating their linkage likelihood according to Equation (3) until convergence. The objective function 𝑂𝑏𝑗(⋅) is defined as the total stationary linkage likelihood summed over all existing links, and 𝜽∗ is then estimated as the parameter vector that maximizes the objective function. 5 Guimerà and Marta (2009) propose a stochastic block model in which social entities are partitioned into groups. Given any two groups η and η′, there is a connection between them if there exists a link between entities 𝑣𝑎 ∈ η and 𝑣𝑏 ∈ η′. Let 𝑃ηη′ be the probability of a connection existing between groups η and η′. Let A denote the adjacency matrix of a social network, where 𝐴𝑎𝑏 = 1 if there is a link between entities 𝑣𝑎 and 𝑣𝑏 in the network and 𝐴𝑎𝑏 = 0 otherwise. Given a partition model M, the likelihood of A is given by 𝐿(𝐴𝑀) = ∏ 𝑃 𝑙ηη′ ηη′ (1 − 𝑃ηη′) 𝑟ηη′−𝑙ηη′, η≤η′ (4) where 𝑙ηη′ is the number of existing connections between groups η and η′ and 𝑟ηη′ is the number of possible connections between groups η and η′. Using Equation (4) as the objective function, we obtain the maximum likelihood estimation of 𝑃ηη′ as ∗ = 𝑃ηη′ 𝑙ηη′ 𝑟ηη′ . The linkage likelihood 𝐿𝑖𝑗 between social entities 𝑣𝑖 and 𝑣𝑗 is then given by 𝐿𝑖𝑗 = ∫ 𝑃(𝐴𝑖𝑗 = 1𝑀)𝐿(𝑀𝐴)𝑑𝑀 , 𝚳 where 𝚳 is the space of all possible partition models. By applying Bayes’ Theorem, we can rewrite Equation (6) as 𝐿𝑖𝑗 = ∫ 𝑃(𝐴𝑖𝑗 = 1𝑀)𝐿(𝐴𝑀)𝑃(𝑀)𝑑𝑀 𝚳 ∫ 𝐿(𝐴𝑀)𝑃(𝑀)𝑑𝑀 𝚳 , (5) (6) (7) where 𝑃(𝑀) is the prior probability of partition model M and 𝐿(𝐴𝑀) can be obtained using Equation (4) ∗ with 𝑃ηη′ . In practice, it is not possible to enumerate all possible partition models and the Metropolis algorithm is applied to sample partition models (Metropolis et al. 1953). Clauset et al. (2008) propose a similar method, in which social entities are grouped into a hierarchical structure. Huang (2010) argues that the linkage likelihood between social entities 𝑣𝑖 and 𝑣𝑗 depends on the number of existing paths connecting them. Let 𝑐𝑧 be the probability of linking 𝑣𝑖 and 𝑣𝑗 given that there 6 exists a length-z path connecting them, 𝑧 ≥ 2. According to Huang (2010), the linkage likelihood 𝐿𝑖𝑗 between social entities 𝑣𝑖 and 𝑣𝑗 can be predicted as 𝐿𝑖𝑗 = 1 − (1 − 𝑐2)𝑚2(1 − 𝑐3)𝑚3 ⋯ (1 − 𝑐𝑘)𝑚𝑘, (8) where 𝑚𝑧 denotes the number of existing length-z paths connecting 𝑣𝑖 and 𝑣𝑗, 𝑧 = 2,3, … , 𝑘. To compute 𝐿𝑖𝑗, we need to estimate parameters in 𝜽 =< 𝑐2, 𝑐3, … , 𝑐𝑘 >. Huang (2010) proposes to estimate 𝜽 based on a generalized variant of the clustering coefficient, which indicates the tendency of a path to form a cycle (Watts and Strogatz 1998, Newman et al. 2001). Considering a social network as a graph, Huang (2010) computes its clustering coefficient 𝐶𝐶𝑘 as 𝐶𝐶𝑘 = 𝑐𝑦𝑐𝑙𝑒<𝑘> , 𝑝𝑎𝑡ℎ<𝑘> (9) where 𝑝𝑎𝑡ℎ<𝑘> denotes the set of length-𝑘 paths and 𝑐𝑦𝑐𝑙𝑒<𝑘> represents the set of cycles each of which is formed by adding a link to a length-𝑘 path in 𝑝𝑎𝑡ℎ<𝑘>. By adding a link connecting 𝑣𝑖 and 𝑣𝑗 with probability 𝐿𝑖𝑗, the expected clustering coefficient of the social network is a function of 𝜽, i.e., 𝑓(𝑐2, 𝑐3, … , 𝑐𝑘). According to Huang (2010), we have 𝑓(𝑐2, 𝑐3, … , 𝑐𝑘) ≈ 𝐶𝐶𝑘. Therefore, each parameter in 𝜽 can be estimated as ∗ = argmin 𝑐𝑧 (𝑓(𝑐2, 𝑐3, … , 𝑐𝑖, … , 𝑐𝑘) − 𝐶𝐶𝑘), 𝑐𝑧 (10) where 𝑧 = 2,3, … , 𝑘. Hopcroft et al. (2011) develop a method based on social network theories such as homophily theory. According to Hopcroft et al. (2011), the linkage likelihood 𝐿𝑖𝑗 between social entities 𝑣𝑖 and 𝑣𝑗 is predicted as 𝐿𝑖𝑗 = 𝑃(𝑦𝑖𝑗 = 1𝒇𝑖𝑗, 𝜽∗), (11) where 𝑦𝑖𝑗 = 1 indicates the linkage between social entities 𝑣𝑖 and 𝑣𝑗, feature vector 𝒇𝑖𝑗 is constructed based on social network theories, and 𝜽∗ is the parameter vector to be learned. Specifically, 𝜽∗ is 7 estimated as the parameter vector that best explains observed link establishments using a gradient descent method (Hopcroft et al. 2011). Backstrom and Leskovec (2011) propose a supervised random walk method to predict linkage likelihood. They define a transition matrix with the social entities in a social network as indices. Each element of the transition matrix is a transition probability from one entity to another and it is defined as an exponential function or a logistic function 𝑎𝑖𝑗 = exp(𝒇𝑖𝑗 ⋅ 𝜽∗), 𝑎𝑖𝑗 = 1 1 + exp(−𝒇𝑖𝑗 ⋅ 𝜽∗) , (12) (13) where 𝒇𝑖𝑗 is a feature vector. To compute the linkage likelihood 𝐿𝑖𝑗 between entities 𝑣𝑖 and 𝑣𝑗, a random walk with restart is started from 𝑣𝑖 according to the transition matrix and 𝐿𝑖𝑗 is the stationary probability of reaching 𝑣𝑗 from 𝑣𝑖. Backstrom and Leskovec (2011) estimate 𝜽∗ as the parameter vector that minimizes a loss function defined based on the difference between the stationary probability from 𝑣𝑖 to one of its currently linked social entities and the stationary probability from 𝑣𝑖 to one of the social entities that it is currently not linked to. Yang et al. (2011) develop a similar linkage prediction method that combines a random walk model with collaborative filtering techniques. 2.3 Relational Learning-based Methods Relational learning represents data using a relational model; it then learns and infers based on the model (Friedman et al. 1999, Getoor et al. 2001, Taskar et al. 2003, Heckerman et al. 2004). Specifically, a relational model consists of two components: relational data model (𝑀𝐷) and dependency structure model (𝑀𝑆). A relational data model consists of a set of classes 𝑿 = {𝑋𝑐}, each of which is described by a set of descriptive attributes 𝑨(𝑋𝑐) (Getoor and Taskar 2007). For example, as shown in Figure 1, PAPER class 𝑋𝑝𝑎𝑝𝑒𝑟 has descriptive attributes such as topic area, keyword, and journal, i.e., 𝑨(𝑋𝑝𝑎𝑝𝑒𝑟) = {𝐴𝑟𝑒𝑎, 𝐾𝑒𝑦𝑤𝑜𝑟𝑑, 𝐽𝑜𝑢𝑟𝑛𝑎𝑙}. Each class 𝑋𝑐 is associated with a set of linkage relationships 𝑹(𝑋𝑐). In 8 Figure 1, a linkage relationship 𝑥𝑝𝑎𝑝𝑒𝑟. 𝜌 ∈ 𝑹(𝑋𝑝𝑎𝑝𝑒𝑟) of a paper 𝑥𝑝𝑎𝑝𝑒𝑟 ∈ 𝑋𝑝𝑎𝑝𝑒𝑟 represents its citation of other papers. PAPER Class Citation PaperID Area Keyword Journal P1 P2 P3 P4 AI Data Mining Data Mining AI Representation Clustering Association Rule Reasoning J1 J2 J1 J1 Citing Cited P1 P2 P3 P4 P3 P1 Figure 1: An Example of Relational Data Model (𝑀𝐷) A dependency structure model represents the dependencies among the descriptive attributes and linkage relationships of a class. Using the PAPER class in Figure 1 as an example, a dependency structure model shown in Figure 2 captures the following dependencies: (a) the area of a paper depends on the journal in which it is published, (b) the keyword of a paper depends on its area, and (c) linkage relationships (e.g., citations) among papers depends on their areas, keywords, and published journals. Dependencies can be learned from data or constructed using background knowledge (Getoor and Taskar 2007). 𝑋𝑃𝑎𝑝𝑒𝑟. 𝐴𝑟𝑒𝑎 (b) 𝑋𝑃𝑎𝑝𝑒𝑟. 𝐾𝑒𝑦𝑤𝑜𝑟𝑑 (a) (c) (c) 𝑋𝑃𝑎𝑝𝑒𝑟. 𝐽𝑜𝑢𝑟𝑛𝑎𝑙 (c) 𝑋𝑃𝑎𝑝𝑒𝑟. 𝐶𝑖𝑡𝑎𝑡𝑖𝑜𝑛 Figure 2: An Example of Dependency Structure Model (𝑀𝑆) Given a dependency structure model, the distribution of a descriptive attribute 𝑥𝑐. 𝐴 and the distribution of a linkage relationship 𝑥𝑐. 𝜌 can be derived as 𝑃(𝑥𝑐. 𝐴𝑃𝑎(𝑥𝑐. 𝐴)) and 𝑃(𝑥𝑐. 𝜌𝑝𝑎(𝑥𝑐. 𝜌) respectively, where 𝑃𝑎(⋅) denotes the parents of a descriptive attribute or a linkage relationship in a dependency structure model. The objective of relational learning is to obtain a vector of parameters 𝜽 such that the following data likelihood function for an instance 𝑰 of a relational model is maximized. 𝑙(𝜽𝑀𝐷, 𝑀𝑆, 𝑰) = ∏ ∏ ∏ 𝑃(𝑥𝑐. 𝐴𝑃𝑎(𝑥𝑐. 𝐴)) ∏ 𝑃(𝑥𝑐. 𝜌𝑃𝑎(𝑥𝑐. 𝜌)) . 𝑋𝑐∈𝑿 𝑥𝑐∈𝑋𝑐 𝐴∈𝑨(𝑋𝑐) 𝜌∈𝑹(𝑋𝑐) 9 (14) The obtained optimal parameters 𝜽∗ can then be used to infer the probability of a linkage relationship (e.g., citation) and the distribution of a missing descriptive attribute (Getoor et al. 2003). To apply relational learning to the link recommendation problem, we can treat linkage likelihood in link recommendation as the probability of a linkage relationship in relational learning (Getoor et al. 2003). In this vein, Bilgic et al. (2007) show that inferring the distributions of missing descriptive attributes can help the estimation of linkage likelihood. In addition to Bayesian Network-based relational learning depicted in Equation (14), there are other relational learning methods that can be applied to link recommendation. For example, Markov Network-based relational learning has been used for link recommendation (Taskar et al. 2003, Mihalkova et al. 2011). Moreover, Heckerman et al. (2001) introduce a relational dependency network for relational learning, Popescul and Ungar (2003) develop a relational learning method based on the structural logistic regression model, Heckerman et al. (2004) design a relational learning model based on the Entity-Relationship diagram, and Yu et al. (2007) propose a non-parametric stochastic approach to relational learning. 3. Proximity-based Methods Proximity-based methods surrogate the linkage likelihood between social entities using the proximity between them (Liben-Nowell and Kleinberg 2007, Chen et al. 2009, Crandall et al. 2010, Lü and Zhou 2011). According to homophily theory (McPherson et al. 2001), similar social entities are of high tendency to link to each other. In light of this theory, the greater the proximity between social entities the higher the linkage likelihood between them. Proximity-based methods can generally be grouped into nodal proximity-based methods and structural proximity-based methods. 3.1 Nodal Proximity-based Methods Nodal proximity-based methods surrogate the linkage likelihood 𝐿𝑖𝑗 between social entities 𝑣𝑖 and 𝑣𝑗 using their nodal proximity 𝑆(𝒀𝑖, 𝐘𝑗), where 𝒀𝑖 and 𝒀𝑗 denote the profile of social entities 𝑣𝑖 and 𝑣𝑗 respectively and 𝑆(⋅) is a similarity function. The profile of a social entity consists of its intrinsic 10 characteristics, including demographic, geographic, and semantic characteristics. Demographic characteristics, such as age, education, and occupation, are commonly used (Zheleva et al. 2008, Xu and Rockmore 2012). Geographic characteristics, such as co-location and distance, have also been employed to capture the closeness between two social entities in a physical space (Quercia and Capra 2009, Crandall et al. 2010, Yin et al. 2010, Scellato et al. 2011, Wang et al. 2011). Semantic characteristics, such as keywords, annotation tags, and communication descriptions, are used to measure the similarity between social entities in terms of their semantic patterns (Shen et al. 2006, Chen et al. 2009, Schifanella et al. 2010, Yin et al. 2010, Makrehchi 2011, Adali et al. 2012, Kuo et al. 2013, Yuan et al. 2014). A number of similarity functions have been applied to measure nodal proximity. For profiles with numerical characteristics, cosine similarity has been employed (Chen et al. 2009, Shen et al. 2006, Schifanella et al. 2010, Wang et al. 2011). According to Salton (1989), the cosine similarity between social entities 𝑣𝑖 and 𝑣𝑗 is given by 𝐶𝑆(𝒀𝑖, 𝒀𝑗) = ∑ 𝑌𝑖𝑘𝑌𝑗𝑘 𝑘 , 2 √∑ 𝑌𝑖𝑘 𝑘 2 ∑ 𝑌𝑗𝑘 𝑘 (15) where 𝑌𝑖𝑘 is the 𝑘𝑡ℎ characteristic in 𝒀𝑖. Another similarity function suitable for numerical characteristics is KL-divergence (Shen et al. 2006). Concretely, the KL-divergence between social entities 𝑣𝑖 and 𝑣𝑗 is computed as 𝐾𝐿(𝒀𝑖, 𝒀𝑗) = ∑ ℎ𝑖𝑘 log 𝑘 ℎ𝑖𝑘 ℎ𝑗𝑘 + ℎ𝑗𝑘 log ℎ𝑗𝑘 ℎ𝑖𝑘 , (16) where ℎ𝑖𝑘 is the probability of the 𝑘𝑡ℎ characteristic in 𝒀𝑖. Manhattan distance has been used to gauge the dissimilarity between social entities (Wang et al. 2011, Adali et al. 2012). Specifically, the Manhattan distance between social entities 𝑣𝑖 and 𝑣𝑗 is defined as 𝑀𝐷(𝒀𝑖, 𝒀𝑗) = ∑𝑌𝑖𝑘 − 𝑌𝑗𝑘 . 𝑘 11 (17) For profiles with nominal characteristics, Jaccard coefficient is a suitable similarity function (Schifanella et al. 2010, Scellato et al. 2011, Wang et al. 2011, Xu and Rockmore 2012, Kuo et al. 2013). In particular, the Jaccard coefficient between social entities 𝑣𝑖 and 𝑣𝑗 is defined as 𝐽𝐶(𝒀𝑖, 𝒀𝑗) = 𝒀𝑖 ∩ 𝒀𝑗 𝒀𝑖 ∪ 𝒀𝑗 . (18) In addition to the above-reviewed similarity functions, other similarity functions such as match count have also been used (Kahanda and Neville 2009, Xiang et al. 2010). 3.2 Structural Proximity-based Methods Structural proximity measures the proximity between two social entities based on their structural features in a social network (Jeh and Widom 2002, Liben-Nowell and Kleinberg 2007, Lü et al. 2009, Lü and Zhou 2011, Liu and Lü 2010). Structural proximity-based methods surrogate the linkage likelihood 𝐿𝑖𝑗 between social entities 𝑣𝑖 and 𝑣𝑗 with their structural proximity (Liben-Nowell and Kleinberg 2007), which can be classified into neighborhood-based structural proximity and path-based structural proximity. 3.2.1 Neighborhood-based Structural Proximity Structural proximity between social entities can be measured based on their neighborhoods. Common neighbor is a widely used neighborhood-based structural proximity measure (Newman 2001, Liben- Nowell and Kleinberg 2007). The common neighbor 𝐶𝑁𝑖𝑗 between social entities 𝑣𝑖 and 𝑣𝑗 is computed as the number of their mutual neighbors, i.e., 𝐶𝑁𝑖𝑗 = Γ𝑖 ∩ Γ𝑗, (19) where Γ𝑖 and Γ𝑗 denote the set of direct neighbors of entities 𝑣𝑖 and 𝑣𝑗 respectively and ⋅ is the cardinality of a set. Extended from the common neighbor measure, the Adamic/Adar measure assigns less weight to more connected common neighbors (Adamic and Adar 2003, Liben-Nowell and Kleinberg 2007). Specifically, the Adamic/Adar 𝐴𝐴𝑖𝑗 between social entities 𝑣𝑖 and 𝑣𝑗 is given by 𝐴𝐴𝑖𝑗 = ∑ 𝑣𝑧∈Γ𝑖∩Γ𝑗 1 log Γ𝑧 , 12 (20) where 𝑣𝑧 is a common neighbor of 𝑣𝑖 and 𝑣𝑗 and Γ𝑧 denotes the set of direct neighbors of 𝑣𝑧. It has been shown theoretically and empirically that the linkage likelihood between social entities is highly correlated with their neighborhood sizes (Barabási and Albert 1999, Newman 2001, Barabási et al. 2002, Liben- Nowell and Kleinberg 2007). Motivated by these theoretical and empirical findings, the preferential attachment 𝑃𝐴𝑖𝑗 between social entities 𝑣𝑖 and 𝑣𝑗 is defined as 𝑃𝐴𝑖𝑗 = Γ𝑖 × Γ𝑗. (21) Observing that two social entities are similar if their neighbors are similar, Jeh and Widom (2002) propose the SimRank measure. The SimRank score 𝑆𝑅𝑖𝑗 between social entities 𝑣𝑖 and 𝑣𝑗 is defined as (Jeh and Widom 2002, Liben-Nowell and Kleinberg 2007, Liu and Lü 2010) 𝑆𝑅𝑖𝑗 = 𝛾 ⋅ ∑ 𝑣𝑧∈Γ𝑖 ∑ 𝑣𝑧′ ∈Γ𝑗 𝑆𝑅𝑧𝑧′ Γ𝑖 ⋅ Γ𝑗 , (22) where 𝛾 ∈ (0,1) is a decay factor. A variation of the SimRank measure is proposed by Leicht et al. (2006). In addition to the measures reviewed in this subsection, there other neighborhood-based measures, such as the Sørensen Index (Sørensen 1948), the Salton Measure (Salton and McGill 1986), and the Hub Promoted (HP)/Hub Depressed (HD) Index (Ravasz et al. 2002). 3.2.2 Path-based Structural Proximity Going beyond neighborhoods, path-based structural proximity measures target paths connecting social entities. The Katz index measures the structural proximity between social entities using the number of paths connecting them, weighted by their lengths (Katz 1953). Originally developed for measuring the social status of a social entity, the Katz index has been shown to be effective in predicting linkage between social entities (Liben-Nowell and Kleinberg 2007). The Katz index 𝐾𝑍𝑖𝑗 between social entities 𝑣𝑖 and 𝑣𝑗 is given by (Katz 1953) 𝐾𝑍𝑖𝑗 = ∑ 𝛽𝑘 𝑝𝑎𝑡ℎ𝑖𝑗 <𝑘>, 𝑘 13 (23) where 𝑝𝑎𝑡ℎ𝑖𝑗 <𝑘> represents the set of length-k paths connecting 𝑣𝑖 and 𝑣𝑗 and weight 𝛽 is between 0 and 1. According to Equation (23), the contribution of a path to the Katz index decreases as its length increases. The local path index (Zhou et al. 2009) is a localized version of the Katz index, where k in Equation (23) is upper bounded. Considering link establishment between social entities as a random walk from one to the other, the PageRank algorithm (Brin and Page 1998) can be adapted to compute structural proximity between them (Haveliwala 2002, Jeh and Widom 2003, Tong et al. 2006). Let 𝑷 be a transition matrix with element 𝑃𝑥𝑦 representing the transition probability from social entity 𝑣𝑥 to entity 𝑣𝑦, where 𝑃𝑥𝑦 = 1 Γ𝑥 if 𝑒𝑥𝑦 ∈ 𝐸 and 𝑃𝑥𝑦 = 0 otherwise. Let 𝒒𝑖 be a vector of probabilities, each element of which represents the probability 𝑗 from social entity 𝑣𝑖 to another entity in a social network. For example, element 𝑞𝑖 represents the probability from 𝑣𝑖 to 𝑣𝑗. According to Tong et al. (2006), we have 𝒒𝑖 = 𝛼𝑷𝑇𝒒𝑖 + (1 − 𝛼)𝝐𝒊, (24) where the 𝑖𝑡ℎ element in vector 𝝐𝒊 is 1 and all other elements are 0.We can iteratively compute 𝒒𝑖 according to Equation (24) until convergence. The PageRank-based structural proximity 𝑃𝑅𝑖𝑗 between 𝑣𝑖 and 𝑣𝑗 is calculated as 𝑃𝑅𝑖𝑗 = 𝑞𝑖 𝑗 + 𝑞𝑗 𝑖 . (25) Based on a similar idea of treating link establishment as a random walk, Fouss et al. (2007) define the hitting time 𝐻𝑖𝑗 as the expected number of steps needed to reach social entity 𝑣𝑗 from entity 𝑣𝑖 for the first time. Let 𝑏𝑥𝑦 denote the weight between entities 𝑣𝑥 and 𝑣𝑦, where 𝑏𝑥𝑦 > 0 if 𝑣𝑥 and 𝑣𝑦 are linked and 𝑏𝑥𝑦 = 0 otherwise. To reach 𝑣𝑗 from 𝑣𝑖, one needs to go to a neighbor 𝑣𝑘 of 𝑣𝑖 and then proceeds from 𝑣𝑘 to 𝑣𝑗. Accordingly, the hitting time 𝐻𝑖𝑗 can be measured as 𝐻𝑖𝑗 = 1 + ∑ 𝑃𝑖𝑘 𝐻𝑘𝑗. 𝑘 14 (26) where 𝑃𝑖𝑘 is the probability of moving from 𝑣𝑖 to its neighbor 𝑣𝑘 and 𝑃𝑖𝑘 = 𝑏𝑖𝑘/ ∑ 𝑏𝑖𝑧 𝑧 . The hitting time 𝐻𝑖𝑗 can be computed recursively according to Equation (26) using a Markovian algorithm (Kemeny and Snell 1976) or can be obtained using the pseudoinverse of the Laplacian matrix of a social network (Fouss et al. 2007). The average commute time 𝐴𝐶𝑇𝑖𝑗 is a symmetric variation of 𝐻𝑖𝑗. Specifically, the average commute time 𝐴𝐶𝑇𝑖𝑗 is defined as the expected number of steps needed to reach 𝑣𝑗 from 𝑣𝑖 for the first time and then to go back to 𝑣𝑖 from 𝑣𝑗 (Fouss et al. 2007). Thus, 𝐴𝐶𝑇𝑖𝑗 is measured as (Fouss et al. 2007) Liben-Nowell and Kleinberg (2007) define the normalized average commute time 𝐴𝐶𝑇𝑖𝑗 ′ as 𝐴𝐶𝑇𝑖𝑗 = 𝐻𝑖𝑗 + 𝐻𝑗𝑖. 𝐴𝐶𝑇𝑖𝑗 ′ = 𝐻𝑖𝑗 ⋅ 𝜋𝑗 + 𝐻𝑗𝑖 ⋅ 𝜋𝑖, (27) (28) where 𝜋𝑗 and 𝜋𝑖 represent the stationary probability of reaching 𝑣𝑗 and 𝑣𝑖 respectively. Since 𝐻𝑖𝑗, 𝐴𝐶𝑇𝑖𝑗, and 𝐴𝐶𝑇𝑖𝑗 ′ are all distance-based measures, a higher value of these measures indicates less linkage likelihood (Liben-Nowell and Kleinberg 2007). 3.2.3 Performance Improvement Several approaches have been proposed to improve the performance of structural proximity-based methods. A social network can be represented as an adjacency matrix, each element of which represents whether two social entities are linked or the strength of their linkage. Inspired by the success of matrix factorization techniques in information retrieval and recommender systems (Deerwester et al. 1990, Koren et al. 2009, Rennie and Srebro 2005), Liben-Nowell and Kleinberg (2007) apply singular value decomposition, a matrix factorization technique, to reduce the rank of an adjacency matrix that represents a social network. They show that structural proximities computed using the rank-reduced adjacency matrix can predict linkage more accurately than those calculated from the original adjacency matrix. Other approaches to improving the prediction accuracy of structural proximity-based methods include the aggregation approach (Liben-Nowell and Kleinberg 2007) and the kernel approach (Kunegis and Lommatzsch 2009). 15 Given the huge size of real world social networks, it is imperative to develop efficient approaches to computing structural proximities. One approach (Song et al. 2009, Shin et al. 2012) is developed based on approximation techniques. It trades accuracy for efficiency and produces approximate structural proximities. Another approach calculates structural proximities from a local social network rather than a complete social network and thus improves the efficiency of computing structural proximities (Zhou et al. 2009, Lü et al. 2009, Lichtenwalter et al. 2010, Liu and Lü 2010, Fire et al. 2011). Yet another improvement adds a time dimension to a social network and computes structural proximities from an evolving social network. For example, Huang and Lin (2009) combine time series models and structural proximity measures to predict linkage likelihood at a particular time. Acar et al. (2009) and Dunlavy et al. (2011) create a tensor from a series of adjacency matrices, each of which represents a social network at a particular time; they then compute the Katz index from the tensor. 4. Summary of Link Recommendation Methods In summary, link recommendation methods predict the linkage likelihood for each potential link and recommend potential links with the highest linkage likelihoods. In particular, these methods predict linkage likelihood using machine learning approaches, including classification, probabilistic models, and relational learning, or they surrogate linkage likelihood with proximity measures, such as nodal and structural proximity measures. We therefore categorize link recommendation methods accordingly and list representative works in each category in Table 1. 16 Method Representative Work Classification-based Method Learning-based Method Probabilistic Model-based Method Relational Learning-based Method Nodal Proximity-based Method Proximity-based Method Structural Proximity-based Method (Neighborhood) Structural Proximity-based Method (Path) - O’Madadhain et al. 2005 - Hasan et al. 2006 - Wang et al. 2007 - Lichtenwalter et al. 2010 - Scellato et al. 2011 - Gong et al. 2012 - Bliss et al. 2014 - Zhang et al. 2014 - Kashima and Abe 2006 - Guimerà and Marta 2009 - Huang 2010 - Backstrom and Leskovec 2011 - Hopcroft et al. 2011 - Yang et al. 2011 - Barbieri et al. 2014 - Dong et al. 2015 - Getoor et al. 2003 - Popescul and Ungar 2003 - Taskar et al. 2003 - Yu et al. 2006 - Mihalkova et al. 2011 - Chen et al. 2009 - Crandall et al. 2010 - Schifanella et al. 2010 - Newman 2001 - Barabási et al. 2002 - Jeh and Widom 2002 - Adamic and Adar 2003 - Liben-Nowell and Kleinberg 2007 - Tong et al. 2006 - Liben-Nowell and Kleinberg 2007 Table 1: Categorization of Link Recommendation Methods In comparison to proximity-based methods, learning-based methods have the following advantages. First, the output of a learning-based method is (or can be easily transformed to) the probability that a potential link will be established in the future. For example, a Naïve Bayes-based method outputs the probability of linkage for each potential link. Most proximity-based methods, on the other hand, do not produce probabilities of linkage. Taking nodal proximity-based methods as an example, these methods yield similarity scores between social entities rather than probabilities of linkage. While the outputs of proximity-based methods are adequate for ranking potential links, they are insufficient for more advanced applications that require probabilities of linkage. For example, in many applications, the cost of recommending a wrong potential link that will not be established is different from the cost of missing a 17 true potential link that will be established. In these applications, knowing probabilities of linkage is essential to cost-sensitive link recommendation decisions. Second, well-designed learning-based methods can predict future linkage more accurately than proximity-based methods (Lichtenwalter et al. 2010, Backstrom and Leskovec 2011). This is partly due to the fact that learning-based methods learn to predict future linkage from the ground truth of prior link establishments (Lichtenwalter et al. 2010). Another factor contributes to the advanced prediction performance of learning-based methods is that their prediction performance is stable across different social networks, while the prediction performance of proximity-based methods varies from one network to another (Lichtenwalter et al. 2010). Proximity-based methods, however, have their own merits. First, proximity-based methods do not need a training phase, which is required for learning-based methods. As a consequence, compared to learning-based methods, proximity-based methods save the cost of constructing training data and the cost of learning from training data. Second, many proximity-based methods are easy to implement and widely applied in practice. For example, common neighbor is popularly used by major online social networks for link recommendation. It is called “mutual friend” in Facebook and “shared connection” in LinkedIn. 5. Theoretical Foundations for Link Recommendation Methods Our survey of link recommendation methods suggests that many of these methods are developed based on observations of social phenomena but overlook social and economic theories underlying these phenomena. As we illustrate in Figure 3, the link between link recommendation methods and their foundational theories is largely missing in existing link recommendation studies. In general, a theory explains why a mechanism works and under what circumstances it works (Parsons 1938, Bacharach 1989). In particular, identifying social and economic theories underlying link recommendation methods has the following benefits. First, it helps us understand why and under what situations a link recommendation method works. With this understanding, we can effectively select appropriate methods for link recommendation tasks at hand. Second, it helps us identify limitations of existing methods and design more advanced 18 methods. Third, theories inform us about generic factors that actually affect linkage decisions, which we can use to design novel and effective link recommendation methods. In this section, we identify social and economic theories underlying link recommendation methods and uncover the missing link between them. Observation Inspiration Method Theory Foundation Figure 3: The Missing Link between Social/Economic Theories and Link Recommendation Methods Observations that have inspired existing link recommendation methods can be broadly grouped into three categories. Specifically, it is observed that the decision of linkage between two social entities is affected by (1) the degree of similarity between them (O’Madadhain et al. 2005, Hasan et al. 2006, Wang et al. 2007, Chen et al. 2009, Crandall et al. 2010, Schifanella et al. 2010, Mihalkova et al. 2011, Hopcroft et al. 2011, Scellato et al. 2011, Yang et al. 2011, Gong et al. 2012), (2) linkage decisions of their social neighbors (Newman 2001, Barabási et al. 2002, Jeh and Widom 2002, Adamic and Adar 2003, O’Madadhain et al. 2005, Kashima and Abe 2006, Lichtenwalter et al. 2010, Scellato et al. 2011, Gong et al. 2012), and (3) paths connecting them in a social network (Katz 1953, Hasan et al. 2006, Tong et al. 2006, Wang et al. 2007, Huang 2010, Lichtenwalter et al. 2010, Hopcroft et al. 2011, Gong et al. 2012). These observations can be explained by homophily theory (McPherson et al. 2001), social interaction theory (Becker 1974), and cognitive balance theory (Heider 1958) respectively. We next review these theories and explain why a link recommendation method works based on these theories. Homophily theory states that “a contact between similar people occurs at a higher rate than among dissimilar people” (McPherson et al. 2001). After all, people like to hang out with others who are like them; i.e., birds of a feather flock together. Theoretically, the flow of information from one person to another is a decreasing function of the distance between them in the Blau space, which is defined by 19 socio-demographic dimensions (McPherson 1983). As a consequence, people separated by greater distances in the Blau space (i.e., less similar in terms of socio-demographics) are less likely to be linked (McPherson 1983). Furthermore, people self-select their “social world” by choosing with whom to interact. Similarity localizes communications in a social network and can lead to distinct social niches (McPherson and Ranger-Moore 1991). These self-selection effects and social niches imply that similarity contributes to the establishment of linkage in social networks (McPherson and Ranger-Moore 1991). Homophily theory is the theoretical foundation for a number of link recommendation methods. According to this theory, a person tends to link to another person similar to him or her and the linkage between them further strengthens their similarity (McPherson and Ranger-Moore 1991). This mutual reinforcement between similarity and linkage is the foundation for the link recommendation methods developed by Yang et al. (2011) and Gong (2012). Moreover, homophily theory predicts that “similarity breeds connection” (McPherson et al. 2001), which explains the effectiveness of nodal proximity-based methods (Chen et al. 2009, Crandall et al. 2010, Schifanella et al. 2010). Furthermore, using similarities between user profiles, one can build a Markov network for relational learning-based link recommendation (Mihalkova et al. 2011). In addition, homophily theory also justifies the effectiveness of similarity-based input features for link recommendation methods, including semantic similarities (O’Madadhain et al. 2005, Hasan et al. 2006, Wang et al. 2007), geographic proximities (O’Madadhain et al. 2005, Scellato et al. 2011), similarities on personal interests (Yang et al. 2011), social status similarities (Hopcroft et al. 2011), and demographic similarities (Gong et al. 2012). According to social interaction theory (Becker 1974), when making a social decision, a social entity’s utility depends on the decisions of his or her social neighbors. Specifically, a social decision is a decision that has impacts on the decision maker’s social neighbors (Akerlof 1997). For link recommendation, the decision of linkage is a social decision. Similar to social interaction theory, social decision theory states that the welfare of a decision maker is affected by the outcomes of his or her social neighbors (Akerlof 1997, Maccheroni et al. 2012). Both social interaction theory and social decision theory can be reasoned 20 from the perspective of social information processing (Salancik and Pfeffer 1978). That is, a social entity relies on social information, i.e., information about what others think, to make a social decision (Kelley 1971, Berger and Calabrese 1975, Pfeffer et al. 1976, Salancik and Pfeffer 1978). In particular, a social entity’s decision is affected by the decisions of his or her social neighbors in two ways (Salancik and Pfeffer 1978). First, the entity tends to fit into a social environment by agreeing with his or her social neighbors. Second, the entity’s social neighbors can pass selective information to the entity, thereby affecting the entity’s decision. In short, social interaction theory, social decision theory, and social information processing theory all suggest that a social entity’s decision depends on the decisions of the entity’s social neighbors, which is the theoretical foundation for a group of link recommendation methods. For example, Kashima and Abe (2006) develop a link recommendation method based on the idea that a user’s linkage decision in a social network depends on the linkage decisions of his or her direct friends in the network. Moreover, the influence of a social entity’s neighborhood on the entity’s decision, as suggested by these theories, is also encoded in the development of neighborhood-based structural proximities, which function as independent predictors for link recommendation (Newman 2001, Barabási et al. 2002, Jeh and Widom 2002, Adamic and Adar 2003) or as input features for a link recommendation method (O’Madadhain et al. 2005, Scellato et al. 2011, Gong et al. 2012). Network transitivity distinguishes social networks from other types of networks (Newman and Park 2003). In general, network transitivity refers to the social phenomenon that indirectly associated social entities tend to tie to each other directly (Davis and Leinhardt 1971, Huang 2010). This phenomenon can be explained by cognitive balance theory from a psychological perspective (Heider 1958) or by social focus theory from a sociological standpoint (Homans 1950). According to cognitive balance theory, sentiments (or attitudes) of indirectly associated social entities could become consistent gradually, which in turn could drive them to link to each other (Heider 1958). Social focus theory suggests that people connect with those who share their foci (Homans 1950). Here, a focus is defined as “a social, 21 psychological, legal, or physical entity around which joint activities are organized” (Feld 1981). For example, foci can be workplaces or hangouts. For two indirectly associated social entities, intermediate entities connecting them provide or create foci for them to meet and interact; as a consequence, these indirectly associated social entities are likely to be linked to each other (Feld 1981). Cognitive balance theory and social focus theory are theoretical foundations for link recommendation methods using path- based structural proximities (Katz 1953, Tong et al. 2006) and the probabilistic model-based method proposed by Huang (2010). All of these methods are developed based on network transitivity suggested by these theories. In addition, features constructed based on network transitivity have been used as inputs for several classification-based link recommendation methods (Hasan et al. 2006, Wang et al. 2007, Lichtenwalter et al. 2010, Gong et al. 2012) and the probabilistic model-based link recommendation method proposed by Hopcroft et al. (2011). In summary, we identify major social and economic theories underlying link recommendation methods and explain working mechanisms of link recommendation methods using these theories, thereby uncovering the link between link recommendation methods and their theoretical foundations. Table 2 summarizes these theories and representative link recommendation methods that are grounded in the theories. 22 Theory Representative Work Grounded in Theory Nodal Proximity-based Method - Chen et al. 2009 - Crandall et al. 2010 - Schifanella et al. 2010 Classification-based Method - O’Madadhain et al. 2005 - Hasan et al. 2006 - Wang et al. 2007 - Scellato et al. 2011 - Gong et al. 2012 Probabilistic Model-based Method - Hopcroft et al. 2011 - Yang et al. 2011 Relational Learning-based Method - Mihalkova et al. 2011 Probabilistic Model-based Method - Kashima and Abe 2006 Structural Proximity-based Method (Neighborhood) - Newman 2001 - Barabási et al. 2002 - Jeh and Widom 2002 - Adamic and Adar 2003 Classification-based Method - O’Madadhain et al. 2005 - Lichtenwalter et al. 2010 - Scellato et al. 2011 - Gong et al. 2012 Structural Proximity-based Method (Path) - Tong et al. 2006 Probabilistic Model-based Method - Huang 2010 - Hopcroft et al. 2011 Classification-based Method - Hasan et al. 2006 - Wang et al. 2007 - Lichtenwalter et al. 2010 - Gong et al. 2012 Homophily Theory (McPherson et al. 2001) Social Interaction Theory (Becker 1974) Social Information Processing Theory (Salancik and Pfeffer 1978) Social Decision Theory (Akerlof 1997) Social Focus Theory (Homans 1950) Cognitive Balance Theory (Heider 1958) Table 2: Theoretical Foundations for Link Recommendation Methods 6. Future Research Directions We propose to extend current link recommendation research in several directions, including utility-based link recommendation, diversity of link recommendation, link recommendation from incomplete data, and experimental study of link recommendation. In the following subsections, we identify promising research questions for each of these directions. 23 6.1 Utility-based Link Recommendation Existing link recommendation methods predict the linkage likelihood for each potential link and recommend potential links with the highest linkage likelihoods. Thus, existing methods focus on the accuracy of link recommendation. In addition to accuracy, there are other factors that need to be considered when recommending links. One is the value of link recommendation; i.e., the value of a recommended link if it is established. We illustrate the value of link recommendation using an example of Facebook, whose operator (i.e., Facebook Inc.) harvests the majority of its $7.9 billion revenue from advertisements on the network (Facebook 10-K 2013). Facebook allows an advertisement being placed on the Facebook page of selected users. A Facebook user could interact with the advertisement through actions such as click, comment, like, and share. Such interactions propagate the advertisement to the user’s friends, who could also interact with the advertisement and further propagate it to their friends. As this propagation process continues, the advertisement could reach a much larger number of users than those that were initially selected. Facebook Inc. reaps revenue each time the advertisement reaches a Facebook user. Understandably, a recommended link, if established, leads to a more connected network among Facebook users, which in turn, drives advertisements to reach more users and bring more advertisement revenue to Facebook Inc. In this example, the value of link recommendation is the advertisement revenue brought in by a recommended and established link. Additionally, link recommendation is not costless. For example, in the context of online social network, ineffective link recommendations suggest new friends that are mostly irrelevant for the users. Consequently, new friendships recommended may not be established, and users may feel disappointed and eventually leave the network. Due to the failure of establishing new friendships and the loss of users, an online social network becomes smaller and less connected, resulting in less advertisement revenue being produced. Hence, another critical factor for link recommendation is the cost of link recommendation; i.e., the cost incurred if a recommended link is not established. 24 We propose the utility of link recommendation that integrates the accuracy, value, and cost of link recommendation. Specifically, the utility of a recommended link depends on its linkage likelihood, the value brought in by the link if it is established, and the cost incurred if it is not established. An interesting research question is therefore how to recommend potential links with the highest utilities rather than the highest linkage likelihoods. This research question could be framed as a classification problem with the linkage likelihood, value, and cost of a potential link as predictors (Li et al. 2015). Alternatively, this question could be treated as a cost-sensitive learning problem (Fang 2013), in which, the linkage likelihood of a potential link is predicted using an existing link recommendation method and a cost matrix is constructed based on the value and cost of a potential link. 6.2 Diversity of Link Recommendation Besides accuracy and utility, another important objective of link recommendation is diversity, e.g., recommending friends with diverse backgrounds to a user. Diverse link recommendation benefits both individual users and a social network as a whole. A user who receives friend recommendations with diverse backgrounds could gain accesses to different social communities in a social network (Brandão et al. 2013), thereby obtaining significant social benefits such as a variety of information sources and competitive advantages (Burt 1992). A social network with high structural diversity among its users effectively facilitates the diffusion of information over the network (Ugander et al. 2012). Moreover, such a network is robust in terms of information diffusion efficiency, even after the removal of its well- connected users (Albert et al. 2000, Tanizawa et al. 2005). In addition, according to Eagle et al. (2010), high structural diversity in a social network has been shown to be positively correlated with a high level of socioeconomic well-being of its users (e.g., high income). Despite these benefits, link recommendation diversity, however, has not received much research attention. In this subsection, we propose several research questions in this fruitful area. First, it is necessary to design metrics to gauge the diversity of link recommendation. While a number of measures has been proposed to evaluate the recommendation diversity of recommender systems (e.g., Zhang and 25 Hurley 2008, Vargas and Castells 2011), many of these measures are not readily applicable to measuring the diversity of link recommendation because a recommender system is a user-item bipartite graph whereas link recommendation involves a user-user graph. We therefore suggest some ideas for designing metrics for link recommendation diversity. One possible metric would be the number of connected components among friends recommended to a user. Understandably, a larger number of connected components indicates that recommended friends are distributed in more social groups and hence greater link recommendation diversity. We could also evaluate link recommendation diversity by measuring the diversity of a social network after adding recommended links with classical network metrics such as clustering coefficient (Watts and Strogatz 1998), network diameter (Wasserman and Faust 1994), and number of structural holes (Burt 1992). Second, it would be interesting to empirically evaluate the recommendation diversity of popular link recommendation methods using the designed metrics. Third, methods that balance multiple objectives of link recommendation, such as diversity, utility, and accuracy, are needed. In this vein, we could formulate a problem of maximizing the diversity of link recommendation while maintaining the accuracy (or utility) of link recommendation at a certain level or a problem of maximizing the accuracy (or utility) of link recommendation while maintaining the diversity of link recommendation at a certain level, and develop methods to solve these problems. 6.3 Link Recommendation from Incomplete Data Current link recommendation methods employ observed features of a social network to predict linkage likelihood. Some of these target nodal features (e.g., Backstrom and Leskovec 2011), while others use structural features (e.g., Liben-Nowell and Kleinberg 2007). However, unobserved factors for which we do not have data could also drive link establishments in a social network, in addition to observed features. Consider the following examples:  Parents become friends on Facebook because their children attend the same kindergarten. These parents have quite different profiles and would never become friends if their children were not attending the same kindergarten. 26  A group of researchers who have different backgrounds and are located in geographically separated areas are temporarily assigned to work together on an interdisciplinary project. Some of them then link to each other on LinkedIn. The factors driving the link establishments in these examples are children’s attendance at the same kindergarten and temporary project assignments. We do not have data about these factors (i.e., they are unobserved), partly for the following reasons. First, users may not disclose sensitive information such as which kindergarten their children attend due to privacy concerns. Second, users live in a social environment that is much broader than a social network. As a result, many factors extrinsic to a social network, such as temporary project assignments, could drive link establishments in the network. The sheer number of extrinsic factors that might affect link establishments in a social network make it extremely difficult to collect data about all of them. Existing methods that rely on similarities between observed user profiles fail to predict link establishments in these examples because observed user profiles in these examples are quite dissimilar. Hence, unobserved factors are important for link recommendation. However, we do not have data about unobserved factors, so our data for predicting linkage likelihood are incomplete. Therefore, an interesting research question is how to integrate both observed features and unobserved factors for the purpose of link recommendation. Toward this end, methods built on the expectation-maximization framework (Dempster et al. 1977, Fang et al. 2013a), a classical framework for learning from incomplete data, are needed for link recommendation from incomplete data. 6.4 Experimental Study of Link Recommendation Most link recommendation methods are evaluated using archival data. However, simply using archival data, we cannot differentiate between link establishments due to organic growth and link establishments arising from link recommendation. Furthermore, with archival data alone, it is difficult to assess users’ behavioral and emotional reactions to recommended links. Therefore, it is worthwhile to conduct laboratory or field experiments to evaluate link recommendation methods. In an experiment, we can observe in real time how users react to recommended links, both behaviorally and emotionally, which 27 recommended links they actually establish, and the value of the established links along with the costs of links that are not established. Moreover, we could use laboratory or field experiments to study the delivery mechanisms for link recommendation. Interesting questions in this direction include: How should the user interface that presents recommended links be designed? What are the best timing and frequency for recommending links that will maximize the chance of link establishment? How many links should be recommended to a user? And what incentives can be used to facilitate the establishment of recommended links? In addition, we could design experiments to study the impact of link recommendation on social networks. One interesting question in this direction is to study how link recommendation affects the diffusion of information, opinion, or advertisements in a social network. In short, experimental study provides a means to address interesting link recommendation questions, many of which cannot be answered using archival data alone. By combining laboratory or field experiments and evaluations with archival data, we could produce more comprehensive and convincing evaluations of link recommendation methods. 6.5 Other Future Research Questions There are other interesting future research questions, which we discuss briefly for length consideration. The effectiveness of a link recommendation method decreases over time, because the method was developed based on previous user linkage behaviors and does not capture new user linkage behaviors. Thus, an interesting question is how to maintain the currency of a link recommendation method over time. Prior studies on data stream mining (Aggarwal 2007) and knowledge refreshing (Fang et al. 2013b) provide methodological and theoretical foundations for answering this question. In addition, current link recommendation methods rank potential links by their linkage likelihoods and recommend top-ranked links. Thus, existing methods essentially solve a ranking problem. However, many real world link recommendation situations may be modeled as combinatorial rather than ranking problems. For example, how to recommend a set of K potential links that will collectively bring in the largest advertisement revenue, among all possible combinations of K potential links, is a combinatorial problem. Thus, it is 28 interesting to study how to model and solve combinatorial link recommendation problems. There are also other challenges for link recommendation, such as cold start (Leroy et al. 2010), class imbalance (Rattigan and Jensen 2005, Lichtenwalter et al. 2010), link recommendation in signed social networks (Song et al. 2015, Tang et al. 2015), and link recommendation across multiple (heterogeneous) social networks (Zhang et al. 2014, Dong et al. 2015), which are well documented in the literature and hence are not discussed here. 7. Conclusions We review state-of-the-art link recommendation methods in this survey. We also identify social and economic theories underlying link recommendation methods and uncover the missing link between them. We further suggest several extensions to existing link recommendation studies, including utility-based link recommendation, diversity of link recommendation, link recommendation from incomplete data, and experimental study of link recommendation. We hope this survey serves as a useful summary of what has been done so far as well as a stimulus to the advancement of link recommendation research. References Acar, E., D.M. Dunlavy, T.G. Kolda. 2009. Link Prediction on Evolving Data Using Matrix and Tensor Factorizations. IEEE International Conference on Data Mining Workshops 262-269. Adali, S., F. Sisenda, M. Magdon-Ismail. 2012. Actions Speak as Loud as Words: Predicting Relationships from Social Behavior Data. In Proceedings of the 21st International Conference on World Wide Web (WWW) 689-698. Adamic, L.A., E. Adar. 2003. Friends and Neighbors on the Web. Social Networks 25(3) 211-230. Aggarwal, C. 2007. Data Streams: Models and Algorithms. Springer, New York, NY. Akerlof, G.A. 1997. Social Distance and Social Decisions. Econometrica 65(5) 1005-1027. Albert, R., H. Jeong, and A.L. Barabasi. 2000. Error and Attack Tolerance of Complex Networks. Nature 406(6794) 378-382. Bacharach, S. B. 1989. Organizational Theories: Some Criteria for Evaluation. Academy of Management Review 14(4) 496-515. Backstrom, L., J. Leskovec. 2011. Supervised Random Walks: Predicting and Recommending Links in Social Networks. In Proceedings of the 4th ACM International Conference on Web Search and Data Mining (WSDM) 635-644. Barabási, A., R. Albert. 1999. Emergence of Scaling in Random Networks. Science 286(5439) 509-512. Barabási, A., H. Jeong, Z. Néda, E. Ravasz, A. Schubert, T. Vicsek. 2002. Evolution of the Social Network of Scientific Collaborations. Physica A: Statistical Mechanics and its Applications 311(3) 590-614. 29 Barbieri, N., F. Bonchi, G. Manco. 2014. Who to Follow and Why: Link Prediction with Explanations. In Proceedings of the 20th ACM SIGKDD International Conference on Knowledge Discovery and Data Mining (KDD) 1266-1275. Becker, G. 1974. A Theory of Social Interactions. Journal of Political Economy 82 1063-1093. Benchettara, N., R. Kanawati, C. Rouveirol. 2010. A Supervised Machine Learning Link Prediction Approach for Academic Collaboration Recommendation. In Proceedings of the 4th ACM Conference on Recommender Systems 253-256. Berger, C.R., R.J. Calabrese. 1975. Some Explorations in Initial Interaction and Beyond: Toward a Developmental Theory of Interpersonal Communication. Human Communication Research 1(2) 99- 112. Bliss, C.A., M.R. Frank, C.M. Danforth, P.S. Dodds. 2014. An Evolutionary Algorithm Approach to Link Prediction in Dynamic Social Networks. Journal of Computational Science 5(5) 750-764. Bilgic, M., G.M. Namata, L. Getoor. 2007. Combining Collective Classification and Link Prediction. In Proceedings of Seventh IEEE International Conference on Data 381-386. Brandão, M.A., M.M. Moro, G.R. Lopes, J.P.M. Oliveira. 2013. Using Link Semantics to Recommend Collaborations in Academic Social Networks. In Proceedings of the 22nd International Conference on World Wide Web Companion (WWW) 833-840. Brin, S., L. Page. 1998. The Anatomy of a Large-scale Hypertextual Web Search Engine. Computer Networks 30 107-117. Burt, R. 1992. Structural Holes: The Social Structure of Competition. Harvard University Press, Cambridge, MA. Chen, J., W. Geyer, C. Dugan, M. Muller, I. Guy. 2009. Make New Friends, But Keep the Old: Recommending People on Social Networking Sites. In Proceedings of the 27th International Conference on Human Factors in Computing Systems 201-210. Clauset, A., C. Moore, M.E. Newman. 2008. Hierarchical Structure and the Prediction of Missing Links in Networks. Nature 453(7191) 98-101. Crandall, D. J., L. Backstrom, D. Cosley, S. Suri, D. Huttenlocher, J. Kleinberg. 2010. Inferring Social Ties from Geographic Coincidences. Proceedings of the National Academy of Sciences 107(52) 22436-22441. Davenport, T., D.J. Patil. 2012. Data Scientist: the Sexist Job of the 21st Century. Harvard Business Review 90(10) 70-76. Davis, J. A., S. Leinhardt. 1971. The Structure of Positive Interpersonal Relations in Small Groups. In Sociological Theories in Progress, 2. Houghton-Mifflin, Boston. Deerwester, S., S.T. Dumais, G.W. Furnas, T.K. Landauer. 1990. Indexing by latent semantic analysis. Journal of American Society for Information Science 41(6) 391-407. Dempster, A.P., N.M. Laird, D.B. Rubin. 1977. Maximum Likelihood from Incomplete Data via the EM Algorithm. Journal of the Royal Statistical Society: Series B 39(1) 1-38. Doppa, J. R., J. Yu, P. Tadepalli, L. Getoor. 2010. Learning Algorithms for Link Prediction based on Chance Constraints. In Machine Learning and Knowledge Discovery in Databases 344-360. Springer Berlin Heidelberg. Dong, Y., J. Zhang, J. Tang, N.V. Chawla, B. Wang. 2015. CoupledLP: Link Prediction in Coupled Networks. In Proceedings of the 21th ACM SIGKDD International Conference on Knowledge Discovery and Data Mining (KDD) 199-208. Dunlavy, D.M., T.G. Kolda, E. Acar. 2011. Temporal Link Prediction Using Matrix and Tensor Factorizations. ACM Transactions on Knowledge Discovery from Data 5(2) 1-27. Eagle, N., M. Macy, R. Claxton. 2010. Network Diversity and Economic Development. Science 328(5981) 1029-1031. Facebook 10-K 2013. Form 10-K of Facebook Inc. for the Fiscal Year Ended December 31, 2013. Retrieved from the Securities and Exchange Commission’s Edgar Website https://www.sec.gov/edgar.shtml. 30 Fang, X., P. Hu, Z. Li, W. Tsai. 2013a. Predicting Adoption Probabilities in Social Networks. Information Systems Research 24(1) 128-145. Fang, X., O.R. Liu Sheng, P. Goes. 2013b. When Is the Right Time to Refresh Knowledge Discovered from Data? Operations Research 61(1) 32-44. Fang, X. 2013. Inference-based Naïve Bayes: Turning Naïve Bayes Cost-sensitive. IEEE Transactions on Knowledge and Data Engineering 25(10) 2302-2313. Feld, Scott L. 1981. The Focused Organization of Social Ties. American Journal of Sociology, 86(5) 1015-1035. Fire, M., L. Tenenboim, O. Lesser, R. Puzis, L. Rokach, Y. Elovici. 2011. Link Prediction in Social Networks using Computationally Efficient Topological Features. In Proceedings of Privacy, Security, Risk and Trust and IEEE 3rd International Conference on Social Computing 73-80. Fouss, F., A. Pirotte, J.M. Renders, M. Saerens. 2007. Random-walk Computation of Similarities between Nodes of a Graph with Application to Collaborative Recommendation. IEEE Transactions on Knowledge and Data Engineering 19(3) 355-369. Friedman, N., L. Getoor, D. Koller, A. Pfeffer. 1999. Learning Probabilistic Relational Models. In Proceedings of International Joint Conferences on Artificial Intelligence 1300-1309. Getoor, L., N. Friedman, D. Koller, B. Taskar. 2001. Learning Probabilistic Models of Relational Structure. In Proceedings of International Conference on Machine Learning (ICML) 1 170-177. Getoor, L., N. Friedman, D. Koller, B. Taskar. 2003. Learning Probabilistic Models of Link Structure. Journal of Machine Learning Research 3 679-707. Getoor, L., B. Taskar. 2007. Introduction to Statistical Relational Learning. MIT press. Gong, N.Z., A. Talwalkar, L. Mackey, L. Huang, E.C.R. Shin, E. Stefanov, E.R. Shhi, D. Song. 2012. Jointly Predicting Links and Inferring Attributes using a Social-Attribute Network. In Proceedings of the ACM SIGKDD International Conference on Knowledge Discovery and Data Mining (KDD). Guimerà, R., S. Marta. 2009. Missing and Spurious Interactions and the Reconstruction of Complex Networks. Proceedings of the National Academy of Sciences 106(52) 22073-22078. Hasan, M., V. Chaoji, S. Salem, M. Zaki. 2006. Link Prediction using Supervised Learning. SIAM International Conference on Data Mining Workshop on Link Analysis, Counter-terrorism and Security. Hasan, M., M. Zaki. 2009. A Survey of Link prediction in Social Networks. In Social Network Data Analytics. Springer US. Haveliwala, T. H. 2002. Topic-sensitive PageRank. In Proceedings of the 11th International Conference on World Wide Web (WWW) 517-526. Heckerman, D., D.M. Chickering, C. Meek, R. Rounthwaite, C. Kadie. 2001. Dependency Networks for Inference, Collaborative Filtering, and Data Visualization. Journal of Machine Learning Research 1 49-75. Heckerman, D., C. Meek, D. Koller. 2004. Probabilistic Models for Relational Data. Technical Report MSR-TR-2004-30. Microsoft Research. Heider, F. 1958. The Psychology of Interpersonal Relations. Wiley, New York. Homans, G. C. 1950. The Human Group. Harcourt, Brace, and World, New York. Hopcroft, J., T. Lou, J. Tang. 2011. Who Will Follow You Back?: Reciprocal Relationship Prediction. In Proceedings of the 20th ACM International Conference on Information and Knowledge Management 1137-1146. Huang, Z. 2010. Link Prediction Based on Graph Topology: The Predictive Value of Generalized Clustering Coefficient. Available at SSRN: http://ssrn.com/abstract=1634014 or http://dx.doi.org/10.2139/ssrn.1634014. Huang, Z., D.K.J. Lin. 2009. The Time-Series Link Prediction Problem with Applications in Communication Surveillance. INFORMS Journal on Computing 21(2) 286-303. Jeh, G., J. Widom. 2002. SimRank: A Measure of Structural-context Similarity. In Proceedings of the 8th ACM SIGKDD International Conference on Knowledge Discovery and Data Mining (KDD) 538-543. 31 Jeh, G., J. Widom. 2003. Scaling Personalized Web Search. In Proceedings of the 12th International Conference on World Wide Web (WWW) 271-279. Kahanda, I., J. Neville. 2009. Using Transactional Information to Predict Link Strength in Online Social Networks. In Proceedings of International Conference on Web and Social Media 9 74-81. Kashima, H., N. Abe. 2006. A Parameterized Probabilistic Model of Network Evolution for Supervised Link Prediction. In Proceedings of the 6th International Conference on Data Mining (ICDM) 340- 349. Katz, L. 1953. A New Status Index Derived from Sociometric Analysis. Psychometrika 18(1) 39-43. Kelley, H. H. 1971. Attribution in Social Interaction. General Learning Press, New York. Kemeny, J. G., J.L. Snell. 1976. Finite Markov Chains (Vol. 210). Springer-Verlag, New York. Kim, M., J. Leskovec. 2011. The Network Completion Problem: Inferring Missing Nodes and Edges in Networks. In Proceedings of SIAM International Conference on Data Mining 47-58. Koren, Y., R. Bell, C. Volinsky. 2009. Matrix Factorization Techniques for Recommender Systems. Computer 42(8) 30-37. Kunegis, J., A. Lommatzsch. 2009. Learning Spectral Graph Transformations for Link Prediction. In Proceedings of the 29th International Conference on Machine Learning (ICML) 561-568. Kuo, T.T., R. Yan, Y.Y. Huang, P.H. Kung, S.D. Lin. 2013. Unsupervised Link Prediction using Aggregative Statistics on Heterogeneous Social Networks. In Proceedings of the 19th ACM SIGKDD International Conference on Knowledge Discovery and Data Mining (KDD) 775-783. Leicht, E.A., P. Holme, M.E.J. Newman. 2006. Vertex Similarity in Networks. Physical Review E 73(2) 026120. Leroy, V., B.B. Cambazoglu, F. Bonchi. 2010. Cold Start Link Prediction. In Proceedings of the 16th ACM SIGKDD International Conference on Knowledge Discovery and Data Mining 393-402. Li, Z., X. Fang, X. Bai, O. R. Liu Sheng. 2015. Utility-based Link Recommendation for Online Social Networks. Working Paper. Liben-Nowell, D., J. Kleinberg. 2007. The Link Prediction Problem for Social Networks. Journal of American Society for Information Science and Technology 58(7) 1019-1031. Lichtenwalter, R.N., J.T. Lussier, N.V. Chawla. 2010. New Perspectives and Methods in Link Prediction. In Proceedings of the 16th ACM SIGKDD International Conference on Knowledge Discovery and Data Mining (KDD) 243-252. Liu, W., L. Lü. 2010. Link Prediction based on Local Random Walk. EPL (Europhysics Letters), 89(5) 58007. Lu, Z., B. Savas, W. Tang, I.S. Dhillon. 2010. Supervised Link Prediction Using Multiple Sources. In Proceedings of 10th International Conference on Data Mining (ICDM) 923-928. Lü, L., C.-H. Jin, T. Zhou. 2009. Similarity Index based on Local Paths for Link Prediction of Complex Networks. Physical Review E 80(4) 046122. Lü, L., T. Zhou. 2011. Link Prediction in Complex Networks: A Survey. Physica A: Statistical Mechanics and its Applications 390(6) 1150-1170. Maccheroni, F., M. Marinacci, A. Rustichini. 2012. Social Decision Theory: Choosing within and between Groups. The Review of Economic Studies 79(4) 1591-1636. Makrehchi, M. 2011. Social Link Recommendation by Learning Hidden Topics. In Proceedings of the 5th ACM Conference on Recommender Systems 189-196. McPherson J.M. 1983. Ecology of Affiliation. American Sociological Review 48 519-532. McPherson, J.M., J.R. Ranger-Moore. 1991. Evolution on a Dancing Landscape: Organizations and Networks in Dynamic Blau Space. Social Forces 70 19−42. McPherson, M., L. Smith-Lovin, J.M. Cook. 2001. Birds of a Feather: Homophily in Social Networks. Annual Review of Sociology 27 415–444. Metropolis, N., A.W. Rosenbluth, M.N. Rosenbluth, A.H. Teller, E. Teller. 1953. Equation of State Calculations by Fast Computing Machines. Journal of Chemical Physics 21 1087. 32 Mihalkova, L., W. Moustafa, L. Getoor. 2011. Learning to Predict Web Collaborations. In Workshop on User Modeling for Web Applications. Newman, M.E. 2001. Clustering and Preferential Attachment in Growing Networks. Physical Review E 64(2) 025102. Newman, M.E., S.H. Strogatz, D.J. Watts. 2001. Random Graphs with Arbitrary Degree Distributions and Their Applications. Physical Review E 64(2) 026118. Newman, M.E., J. Park. 2003. Why Social Networks Are Different from Other Types of Networks. Physical Review E 68(3) 036122. O'Madadhain, J., J. Hutchins, P. Smyth. 2005. Prediction and Ranking Algorithms for Event-based Network Data. ACM SIGKDD Exploration Newsletter 7(2) 23-30. Parsons, T. 1938. The Role of Theory in Social Research. American Sociological Review 3(1) 13-20. Pfeffer, J., G.R. Salancik, H. Leblebici. 1976. The Effect of Uncertainty on the Use of Social Influence in Organizational Decision Making. Administrative Science Quarterly 21(2) 227-245. Popescul, A., L. Ungar. 2003. Statistical Relational Learning for Link Prediction. In Proceedings of International Joint Conferences on Artificial Intelligence Workshop on Learning Statistical Models from Relational Data 81-90. Quercia, D., L. Capra. 2009. FriendSensing: Recommending Friends using Mobile Phones. In Proceedings of the 3rd ACM conference on Recommender Systems 273-276. Rattigan, M.J., D. Jensen. 2005. The Case for Anomalous Link Discovery. SIGKDD Exploration Newsletter 7(2) 41-47. Ravasz, E., A.L. Somera, D.A. Mongru, Z.N. Oltvai, A. Barabási. 2002. Hierarchical Organization of Modularity in Metabolic Networks. Science 297(5586) 1551-1555. Rennie, J.D.M., N. Srebro. 2005. Fast Maximum Margin Matrix Factorization for Collaborative Prediction. In Proceedings of the 22nd International Conference on Machine Learning 713-719. Salancik, G.R., J. Pfeffer. 1978. A Social Information Processing Approach to Job Attitudes and Task Design. Administrative Science Quarterly 224-253. Salton, G., M.J. McGill. 1986. Introduction to Modern Information Retrieval. McGraw-Hill, New York. Salton, G. 1989. Automatic Text Processing: the Transformation Analysis, and Retrieval of Information by Computer. Addison-Wesley Longman Publishing Co., Inc., Boston. Scellato, S., A. Noulas, C. Mascolo. 2011. Exploiting Place Features in Link Prediction on Location- based Social Networks. In Proceedings of the 17th ACM SIGKDD International Conference on Knowledge Discovery and Data Mining (KDD) 1046-1054. Schifanella, R., A. Barrat, C. Cattuto, B. Markines, F. Menczer. 2010. Folks in Folksonomies: Social Link Prediction from Shared Metadata. In Proceedings of the 3rd ACM International Conference on Web Search and Data Mining (WSDM) 271-280. Shen, D., J.-T. Sun, Q. Yang, Z. Chen. 2006. Latent Friend Mining from Blog Data. In Proceedings of IEEE 6th International Conference on Data Mining (ICDM) 552-561. Shin, D., S. Si, I.S. Dhillon. 2012. Multi-scale Link Prediction. In Proceedings of the 21st ACM International Conference on Information and Knowledge Management 215-224. Song, H.H., T.W. Cho, V. Dave, Y. Zhang, L. Qiu. 2009. Scalable Proximity Estimation and Link Prediction in Online Social Networks. In Proceedings of the 9th ACM SIGCOMM Conference on Internet Measurement Conference 322-335. Song, D., D.A. Meyer, D. Tao. 2015. Efficient Latent Link Recommendation in Signed Networks. In Proceedings of the 21th ACM SIGKDD International Conference on Knowledge Discovery and Data Mining (KDD) 1105-1114. Sørensen, T. 1948. A Method of Establishing Groups of Equal Amplitude in Plant Sociology based on Similarity of Species and Its Application to Analyses of the Vegetation on Danish Commons. Biol. Skr. 5 1-34. Tang, J., S. Chang, C. Aggarwal, H. Liu. 2015. Negative Link Prediction in Social Media. In Proceedings of the Eighth ACM International Conference on Web Search and Data Mining (WSDM) 87-96. 33 Tanizawa, T., G. Paul, R. Cohen, S. Havlin, H.E. Stanley. 2005. Optimization of Network Robustness to Waves of Targeted and Random Attacks. Physical Review E 71(4) 047101. Taskar, T., M.F. Wong, P. Abbeel, D. Koller. 2003. Link Prediction in Relational Data. In Proceedings of Advances in Neural Information Processing Systems 659-666. Tong, H., C. Faloutsos, J.Y. Pan. 2006. Fast Random Walk with Restart and Its Applications. In Proceedings of the Sixth IEEE International Conference on Data Mining (ICDM) 613-622. Ugander, J., L. Backstrom, C. Marlow, J. Kleinberg. 2012. Structural Diversity in Social Contagion. Proceedings of the National Academy of Sciences 201116502. Vargas, S., P. Castells. 2011. Rank and Relevance in Novelty and Diversity Metrics for Recommender Systems. In Proceedings of the 5th ACM Conference on Recommender Systems 109-116. Watts, D. J., S. H. Strogatz. 1998. Collective Dynamics of ‘small world’ Networks. Nature 393(6684) 440-442. Wasserman, S., K. Faust. 1994. Social Network Analysis: Methods and Applications. Cambridge University Press. Wang, C., V. Satuluri, S. Parthasarathy. 2007. Local Probabilistic Models for Link Prediction. In Proceedings of 7th IEEE International Conference on Data Mining (ICDM) 322-331. Wang, D., D. Pedreschi, C. Song, F. Giannotti, A.L. Barabasi. 2011. Human Mobility, Social Ties, and Link Prediction. In Proceedings of the 17th ACM SIGKDD International Conference on Knowledge Discovery and Data Mining (KDD) 1100-1108. Xia, S., B. Dai, E.P. Lim, Y. Zhang, C. Xing. 2012. Link Prediction for Bipartite Social Networks: the Role of Structural Holes. In Proceedings of IEEE/ACM International Conference on Advances in Social Networks Analysis and Mining 153-157. Xiang, R., J. Neville, M. Rogati. 2010. Modeling Relationship Strength in Online Social Networks. In Proceedings of the 19th International Conference on World Wide Web (WWW) 981-990. Xu, Y., D. Rockmore. 2012. Feature Selection for Link Prediction. In Proceedings of the 5th Ph. D. ACM Workshop on Information and Knowledge 25-32. Yang, S.H., B. Long, A. Smola, N. Sadagopan, Z. Zheng, H. Zha. 2011. Like Like Alike: Joint Friendship and Interest Propagation in Social Networks. In Proceedings of the 20th International Conference on World Wide Web (WWW) 537-546. Yin, Z., M. Gupta, T. Weninger, J. Han. 2010. A Unified Framework for Link Recommendation Using Random Walks. In Proceedings of the 2010 International Conference on Advances in Social Networks Analysis and Mining 152-159. Yu, K., W. Chu, S. Yu, T. Volker, Z. Xu. 2007. Stochastic Relational Models for Discriminative Link Prediction. Advances in Neural Information Processing Systems 333-340. Yuan, G., P.K. Murukannaiah, Z. Zhang, M.P. Singh. 2014. Exploiting Sentiment Homophily for Link Prediction. In Proceedings of the 8th ACM Conference on Recommender Systems 17-24. Zhang, M., N. Hurley. 2008. Avoiding Monotony: Improving the Diversity of Recommendation Lists. In Proceedings of ACM Conference on Recommender Systems 123-130. Zhang, J., P.S. Yu, Z.H. Zhou. 2014. Meta-path based Multi-network Collective Link Prediction. In Proceedings of the 20th ACM SIGKDD International Conference on Knowledge Discovery and Data Mining (KDD) 1286-1295. Zheleva, E., L. Getoor, J. Golbeck, U. Kuter. 2008. Using Friendship Ties and Family Circles for Link Prediction. In Advances in Social Network Mining and Analysis. Springer Berlin Heidelberg. Zhou, T., L. Lü, Y.-C. Zhang. 2009. Predicting Missing Links via Local Information. European Physical Journal B - Condensed Matter and Complex Systems 71(4) 623-630. 34
1912.00984
1
1912
2019-12-02T18:23:19
Core-Periphery Structure in Directed Networks
[ "cs.SI", "stat.AP" ]
While studies of meso-scale structures in networks often focus on community structure, core--periphery structures can reveal new insights. This structure typically consists of a well-connected core and a periphery that is well connected to the core but sparsely connected internally. Most studies of core--periphery structure focus on undirected networks. We propose a generalisation of core-periphery structure to directed networks. Our approach yields a family of core-periphery block model formulations in which core and periphery sets are edge-direction dependent. We mainly focus on a particular core--periphery structure consisting of two core sets and two periphery sets which we motivate empirically. To detect this directed core-periphery structure we propose four different methods, with different trade-offs between computational complexity and accuracy. We assess these methods on three benchmarks and compare to four standard methods. On simulated data, the proposed methods match or outperform the standard methods. Applying our methods to three empirical networks -- a political blogs networks, a faculty hiring network, and a trade network -- illustrates that this directed core--periphery structure can offer novel insights about the underlying dataset.
cs.SI
cs
Core -- Periphery Structure in Directed Networks Andrew Elliott1,2, Angus Chiu2, Marya Bazzi1,3,4, Gesine Reinert1,2 and Mihai Cucuringu1,2,4 1 The Alan Turing Institute, London, UK 2 Department of Statistics, University of Oxford, UK 3 Mathematical Institute, University of Warwick, UK 4 Mathematical Institute, University of Oxford, UK Abstract While studies of meso-scale structures in networks often focus on community structure, core -- periphery structures can reveal new insights. This structure typically consists of a well-connected core and a periphery that is well connected to the core but sparsely connected internally. Most studies of core -- periphery structure focus on undirected networks. We propose a generalisation of core -- periphery structure to directed networks. Our approach yields a family of core -- periphery block model formulations in which core and periphery sets are edge-direction dependent. We mainly focus on a particular core -- periphery structure consisting of two core sets and two periphery sets which we motivate empirically. To detect this directed core -- periphery structure we propose four different methods, with different trade-offs between computational complexity and accuracy. We assess these methods on three benchmarks and compare to four standard methods. On simulated data, the proposed methods match or outperform the standard methods. Applying our methods to three empirical networks -- a political blogs networks, a faculty hiring network, and a trade network -- illustrates that this directed core -- periphery structure can offer novel insights about the underlying dataset. 1 Introduction Networks provide useful representations of complex systems across many applications [36], such as physical, technological, information, biological, financial, and social systems. A network in its simplest form is a graph in which vertices represent entities of interest and edges represent pairwise interactions of interest. In weighted graphs, each edge has an associated edge weight; in an unweighted graph, the edge weights are 0 (absent) or 1 (present). Edges can also incorporate directions to represent asymmetric interactions; here, we consider directed unweighted networks (with some methods adaptable to weighted networks). Given a network representation of a system, it can be useful to apply coarse-graining techniques to investigate so-called meso-scale features that lie between the micro-scale (local vertex properties e.g. subgraph counts) and the macro-scale (global network properties e.g., total edge weight, degree distribution, average local clustering coefficient). Typical meso-scale structures are community structure, core -- periphery structure, role structure, and hierarchical structure [36, 43, 40, 5]; often, more than one of these is present in a network, see for example [40]. Communities are the most commonly studied type of meso-scale structure. A community is loosely defined as a set of vertices that are more densely connected to each other than they are to vertices in the rest of the network. Many algorithms have been developed to detect communities, which have led to insights in a wide variety of applications, see for example [41, 18, 36]. 1 In the present paper, we focus on core -- periphery structure. The concept of core -- periphery stems from studies of economic and social networks [43], and was first formalised by Borgatti and Everett [7]. Typically, core -- periphery structure is a partition of an undirected network into two sets, a core and a periphery, such that there are dense connections within the core and sparse connections within the periphery [7]. Furthermore, core vertices are reasonably well-connected to the periphery vertices. Extensions allow for multiple core -- periphery pairs and nested core -- periphery structures [16, 26, 40]. Many algorithms have been developed for detecting (different variants) of core -- periphery structure. These include approaches based on the optimisation of a quality function [7, 43, 20, 50, 52, 40], spectral methods [15, 47, 35], and notions of core -- periphery based on transport (e.g., core vertices are likely to be on many shortest paths between other vertices in the network) rather than edge densities and weights [15, 29]. Core -- periphery detection has been applied to various fields such as economics, sociology, international relations, journal-to-journal networks, and networks of interactions between scientists; see [46] for a recent survey. Many methods for detecting core -- periphery were developed for undirected networks, and al- though they can be (and some have been) generalised to directed graphs, they do not also generalise the definition of a discrete core and periphery to be edge-direction dependent, but rather, either disregard the edge-direction or consider the edge in each direction as an independent observation [40, 3, 48, 7] or use a continuous structure [9]. To the best of our knowledge, the only structure that can be interpreted as a form of generali- sation of core -- periphery structure to directed networks where the definition of core and periphery is edge-direction dependent, is the bow-tie structure [13, 10]. Bow-tie structure consists of a core (defined as the largest connected component), an in-periphery (all vertices with a directed path to a vertex in the core), an out-periphery (all vertices with a directed path from a vertex in the core), and other sets containing any remaining vertices [10, 30, 51]. In this paper, we introduce a generalisation of the block-model core -- periphery structure in- troduced in [7] to directed networks, in which the definition of both core and periphery are edge- direction dependent. We propose four methods to detect the proposed directed core -- periphery structure, and illustrate their performance on synthetic and empirical networks. We include com- parisons to bow-tie structure in our synthetic experiments and illustrate that the structure we propose yields additional insights about empirical networks. Moreover, we suggest a framework for defining cores and peripheries in way that accounts for edge direction, which yields as special cases a bow-tie-like structure and the structure we focus on in the present paper. This paper is organised as follows. In Section 2 we introduce a novel block-model for directed core -- periphery structure that consists of four sets (two periphery sets and two core sets) and a two- parameter synthetic model that can generate the proposed structure. In Section 3 we introduce four methods for detecting the proposed directed core -- periphery structure. The first one is a generalisation of the low-rank approximation approach introduced in [15] (see Section 3.1), the second and third are adaptations and extensions of the HITS algorithm [23] (see Section 3.2), and the fourth is a likelihood-maximisation approach (see Section 3.3). Section 4 illustrates the performance of our methods on synthetic benchmark networks. In Section 5, we apply the methods to three real-world data sets. Section 6 summarises our main results and offers directions for future work. The code for our proposed methods and the implementation for bow-tie structure is available at https://github.com/alan-turing-institute/directedCorePeripheryPaper. 2 2 Core -- periphery structure Core -- periphery structure in undirected networks The most well-known quantitative for- mulation of core -- periphery structure was introduced by Borgatti and Everett [7]. They propose both a discrete and a continuous model for detecting core -- periphery structure in undirected net- works. We describe below the (discrete) block model formulation introduced in [7], which we generalise to directed networks later in this section. In the discrete notion of core -- periphery structure, [7] suggests that a core -- periphery model should consist of two sets: a densely connected core and a loosely connected periphery, with dense connections between the core and the periphery. Formally, let nc denote the number of vertices in the core and np the number of vertices in the periphery, with nc + np = n (i.e., the core and the periphery form a partition of the vertices in the graph). The idealised probability matrix and network representation that match the undirected core -- periphery structure is given by Core Periphery M0 = Core Periphery 1 1 1 0 with corresponding adjacency matrix A0 = (cid:12)(cid:12)(cid:12)(cid:12)1nc×nc 1nc×np 1np×nc 0np×np (cid:12)(cid:12)(cid:12)(cid:12) , (1) (2) where 1n1×n2 (respectively, 0n1×n2) denotes an n1 × n2 matrix in which every entry takes the value 1 (respectively, 0). In adjacency matrices of real-world data sets, any structure of the form Eq. (2), if present, is likely observed with random noise. With sgn denoting the signum function that maps a real number to 1 if the number is positive, to −1 if the number if negative, and to 0 if the number is zero, the block matrix A0 is equivalent (up to row and column permutations) to the matrix with (i, j)th entry sgn(xi + xj), with xi = 1 if i is in the core and 0 otherwise [47]. To detect core -- periphery structure in a graph with adjacency matrix A ∈ {0, 1}n×n, one approach introduced in [7], see also [47], is to optimise the quality function n(cid:88) i,j=1 Aijsgn(xi + xj) , (cid:80)n i=1 xi = nc} for a fixed nc ∈ N. The intuition is that (3) over x = (x1, . . . , xn) ∈ Ω = {x ∈ {0, 1}n the larger the double summation in Eq. (3), the greater the extent to which the adjacency matrix matches the idealised block matrix in Eq. (2). One can use (3) to detect core -- periphery structure in weighted and directed networks [7], and different detection methods for undirected networks build on this formulation by changing the signum function in Eq. (3) [7, 47, 43]. Core -- periphery structure in directed networks Now we introduce a block model for di- rected core -- periphery in which the definitions of the core and periphery sets are edge-direction- dependent. To incorporate information about edge direction in the formulation of the block model itself, we split each of the sets in Eq. (2) into one that has incoming edges and another one that has outgoing edges. This yields four sets in total, which we denote Cin (core-in), Cout (core-out), Pin 3 (periphery-in) and Pout (periphery-out). Within each of the two core sets (Cin and Cout) and pe- riphery sets (Pin and Pout), we adopt the same convention as in Eq. (2): the two core sets are fully internally connected and the two periphery sets have no internal edges. In line with the intuition behind core -- periphery structure, we also assume that edges do not exist between the periphery sets. There are no multiple edges, but there are self-loops. Specifically, we assume the following block probability matrix and corresponding network representation Pout Cin Cout Pin 0 0 0 0 1 0 0 0 1 1 1 0 0 0 1 0 M = Pout Cin Cout Pin (4) To gain some empirical intuition for the structure in Eq. (4), we motivate it with a few real- world examples. Consider networks that represent a type of information flow, with two sets that receive information (Cin and Pin) and two sets that transmit/send information (Cout and Pout). Furthermore, within each of these categories, there is one set with core-like properties and another Inspired by [5], in a Twitter network for example, Cin and one with periphery-like properties. Pin could correspond to consumers of information, with Cin having the added property of being a closely-knit community that has internal discussions (e.g., interest groups) rather than individuals collecting information independently (e.g., an average user). On the other hand, Cout and Pout could correspond to transmitters of information, with Cout having the added property of being a well- known closely-knit community (e.g., broadcasters) rather than individuals spreading information independently (e.g., celebrities). Another class of examples is networks that represent a type of social flux, when there are two sets that entities move out of, and two sets that entities move towards. Furthermore, within each of these categories, there is one with core-like properties and In a faculty hiring network of institutions for example, Cout one with periphery-like properties. may correspond to highly-ranked institutions with sought-after alumni, while Cin may correspond to good institutions which take in more faculty than they let go. For the periphery sets, Pout may correspond to lower-ranked institutions which do not attract faculty from higher-ranked institutions, and Pin may correspond to a set of institutions which attract many alumni from highly-ranked ones. These ideas will be illustrated on real-world data in Section 5. While the extension of Eq. (1) in Eq. (4) can be regarded as a natural one to consider in that the edge-direction dependence is defined in the same way for both core and periphery sets, there are other choices that one can pursue. In Supplementary Information (SI) A, a framework is provided from which one can derive a set of directed core -- periphery structures of which Eq. (4) is one example; they also include a block model formulation of bow-tie structure. Synthetic model for directed core -- periphery structure Here we describe a stochastic block model that we will use as a synthetic graph model to benchmark our methods. Consider a partition with four sets, namely Pout, Cin, Cout and Pin with respective sizes nPout, nCin, nCout and nPin. For any two vertices u, v let X(u, v) be the random variable which equals 1 if there is an edge from u to v, and 0 otherwise. We refer to X(u, v) as an edge indicator. For an edge indicator which should equal 1 according to the perfect structure (Eq. (4)) let p1 be the probability that an edge is observed. Similarly for an edge indicator which should be 0 according to the perfect structure (Eq. (4)) let p2 be the probability that an edge is observed. Thinking of p2 as noise and of p1 as 4 signal, we assume that p1 > p2 so that the noise does not overwhelm the structure Eq. (4). We represent this model as a stochastic block model with probability matrix (cid:12)(cid:12)(cid:12)(cid:12)(cid:12)(cid:12)(cid:12)(cid:12) p2 p1 p2 p2 p2 p1 p2 p2 p2 p1 p1 p1 p2 p2 p2 p2 (cid:12)(cid:12)(cid:12)(cid:12)(cid:12)(cid:12)(cid:12)(cid:12) , p1M + p2(1 − M) = (5) where 1 = 14×4. Setting p1 = 1 and p2 = 0 recovers the idealised block structure in Eq. (4). This two-parameter model allows to increase the difficulty of the detection by reducing the difference be- tween p1 and p2, and to independently modify the expected density of edges matching (respectively, not matching) the planted structure by varying p1 (respectively, p2). A special case of Eq. (5) with p1 = 0.5 + p and p2 = 0.5 − p, p ∈ [0, 0.5], yields the stochastic block model with probability matrix (0.5 + p)M + (0.5 − p)(1 − M) . (6) This model yields the idealised block structure in Eq. (4) when p = 0.5 and an Erdos-R´enyi random graph when p = 0. By varying p between these bounds, one simultaneously varies the expected density of edges that match the planted structure. Examples of both model instances are shown in the first row of Fig. 1. The first three panels of the first row of Fig. 1 show example adjacency matrices obtained with Eq. (5), n = 400, and equally- sized nPout = nCin = nCout = nPin = 100. We fix p2 = 0.1 and vary p1. As p1 decreases with fixed p2, the 'L'-shaped pattern starts to fade away and the sparseness of the network increases. The last three panels show realisations of adjacency matrices obtained with Eq. (6) for p ∈ {0.1, 0.3, 0.45}, n = 400, and four equally-sized blocks. As anticipated, the 'L'-shaped pattern is less clear for larger values of p. We shall return to Fig. 1 in the next section. Figure 1: Heatmaps illustrating our model and the rank-2 SVD approximation. Top row: heatmaps of the original adjacency matrix, with n = 400 vertices. We generate the first three examples with (5) and the second three examples with (6), for which p1 = 0.5 + p and p2 = 0.5 − p, Blocks are equally-sized in both cases. Bottom row: heatmaps of the low-rank SVD reconstruction for the adjacency matrix above it. 5 Original(p1,p2)=(0.8,0.1)(p1,p2)=(0.5,0.1)(p1,p2)=(0.2,0.1)p=0.4p=0.2p=0.05Rank2 SVD0.00.20.40.60.81.0 3 Core -- periphery detection in directed networks The directed core -- periphery block structure in Eq. (4) differs from the original undirected core -- periphery structure in Eq. (1) in two important ways: the structure in Eq. (4) is asymmetric, and it consists of two core sets and two periphery sets, each with their own distinct characteristics. In this section, we describe three method classes for detecting this novel structure, ordered by run time, from fast to slow. From these three method classes we shall select four methods for directed core -- periphery detection. The first is based on a generalisation of the low-rank approximation approach in [15], the second and third are based on an adaptation of the popular HITS algorithm [23], and the fourth is based on likelihood-maximisation. 3.1 Method class 1: Low-rank approximation Our first approach generalises the low-rank approximation method which was developed for undi- rected networks in [15]. For a low-rank approximation of an asymmetric matrix, the singular value decomposition (SVD) of the n × n adjacency matrix A is given by A = UΣVT , where U (left- singular vectors) and V (right singular vectors) are orthogonal n × n matrices and Σ is a n × n diagonal matrix with the so-called singular values on the diagonal. Singular values are real and non-negative, and by convention, sorted in descending order. For a rank-r approximation, we keep the top r singular vectors of U and V. Formally, let Ur (respectively, Vr) be a n× r (respectively, r × n) matrix storing the first r columns of U (respectively, V), and let Σr be a r × r matrix constructed from the first r rows and columns of Σ. A rank-r approximation of A is (cid:98)A = UrΣrVT r , the matrix of rank r with the lowest possible Frobenius error, by the Eckart-Young theorem. Similarly to the undirected case in [15], one can interpret a low-rank approximation as a 'de- noising' of the original adjacency matrix. The appropriate rank of approximation for detecting a given structure is dictated by the rank of the idealised block model. The rank-2 block matrix in Eq. (4) would suggest a rank-2 approximation. The second row of Fig. 1 shows the rank-2 approximations for the synthetic adjacency matrices in the first row of Fig. 1. In all of these cases, a rank-2 approximation of the adjacency matrix is able to highlight the planted 'L' structure. To partition the network vertex set into Pout, Cin, Cout and Pin based on the low-rank approx- imation in Eq. (7) with r = 2, we use a score which is analogous to the degree-based score of [15] for the undirected case. Let the in- or out-degree of a set be the sum of the in- or out-degrees of its vertices. In a network which perfectly matches the directed core-periphery structure (4), the in-degree of Pout would be 0, the out-degree of Pin would be 0, the in-degree of Cin would equal (nPout + nCout + nCin ) nCin , and also the out-degree of Cout would equal (nPin + nCout + nCin ) nCout. We denote by CLR in (i) the Cin score of vertex i with respect to our low rank method, with equivalent formulations for the remaining sets. Based on the idealised block structure in Eq. (4), Cin should have the highest number of incoming edges and Cout the highest number of out-going edges. Accordingly, one would expect a vertex i to contribute more to the CLR in score if it has high in-degree, and to contribute more to the CLR out score if it has high out-degree. We thus set (7) (8) n(cid:88) (cid:98)Aji, n(cid:88) (cid:98)Aij, CLR in (i) = CLR out (i) = j=1 j=1 6 matrix (cid:98)A from Eq. (7). Similarly, based on the idealised structure in Eq. (4), a vertex should have which yield the in-degree and out-degree, respectively, of vertex i in the network with adjacency a high PLR have a high PLR in score if it has low out-degree compared to the maximal out-degree, and a vertex should out score if it has low in-degree compared to the maximal in-degree. We set (cid:33) (cid:33) (cid:98)Aja (cid:98)Aaj (cid:32) n(cid:88) (cid:32) n(cid:88) a=1 a=1 n(cid:88) n(cid:88) a=1 a=1 − − (cid:98)Aia = maxj (cid:98)Aai = maxj (cid:0)CLR out (j)(cid:1) (cid:0)CLR in (j)(cid:1) P LR in (i) =maxj P LR out (i) =maxj − CLR out (i), − CLR in (i). (9) (10) In SI C we consider alternative variants of these scores and note that the above scores achieve the best performance on the synthetic benchmarks. out, PLR out, CLR in , CLR To convert the scores into a partition of a network, we consider the n × 4 score matrix SLR = [PLR in ]. We normalise each row of SLR such that it has an L2-norm of 1. Heuristically the normalisation allows the rows of SLR (vectors in 4-dimensional space) not only to concentrate in four different directions, but to do so while also having a small within-set Euclidean distance [14, 28]. We then partition the vertices by clustering SLR using k-means++ [2], a variant of the popular k-means clustering algorithm that alleviates the issues of unstable clusterings retrieved by k-means [32]. We refer to this method as LowRank. 3.2 Method class 2: The Hyperlink-Induced Topic Search (HITS) algorithm Our second method builds on a well-known algorithm in link analysis known as Hyperlink-Induced Topic Search (HITS) [23]. Similarly to PageRank, the HITS algorithm was originally designed to measure the importance of webpages or other documents using the structure of the directed links between the webpages [8]. The underlying intuition is that authoritative webpages on a topic should not only have large in-degrees (i.e., they constitute hyperlinks on many webpages) but should also considerably overlap in the sets of pages that point to them. There exists a mutually reinforcing relationship between authoritative webpages for a topic, referred to as "authorities", and pages that link to many related authorities, referred to as "hubs". A good hub is a page that points to many good authorities, and a good authority is a page that is pointed to by many good hubs. Consequently, the HITS algorithm assigns to each webpage two vertex-based scores the "authority scores" a and the "hub scores" h, with the following recursive relationship a = AT h and h = Aa . The HITS algorithm determines the scores iteratively. Initially, all authority and hub scores are set to 1n. At each iteration of the HITS algorithm, one sequentially updates the authority and hub scores. A normalisation step is then applied, so that the vectors a and h become unit vectors in some norm [8]. Kleinberg [23] proves that the algorithm converges to the principal left and right singular vectors of the adjacency matrix A, provided that the initial authority and hub vectors are not orthogonal to the principal eigenvectors of AT A and AAT . We use this method in two ways: (i) we construct a score based directly on the hub and authority scores, (ii) we generalise this method from the case of two scores (hub and authority) to the case of four scores, motivated by the four sets in our directed core-periphery structure. Direct use of HITS scores. To construct the CHIT S scores, we begin by noting that a vertex would have a high authority score if it has many incoming edges, whereas it , CHIT S , PHIT S , PHIT S out out in in 7 would have a high hub score if it has many outgoing edges. Based on the idealised block structure in Eq. (4), vertices with the highest authority scores should also have a high CHIT S score, and vertices with the highest hub scores should also have a high CHIT S score. We let in out CHIT S in (i) = h(i) and CHIT S out (i) = a(i). To set the remaining scores we use the same intuition as for the low-rank setting, and let in P HIT S P HIT S out (i) =maxj(CHIT S (i) =maxj(CHIT S out in out (j)) − CHIT S (j)) − CHIT S in (i) , (i) . (11) (12) We then cluster the resulting scores using the same procedure used for LowRank (see Section 33.1), and following LowRank we refer to this method as HITS. Recalling the relation between the HITS algorithm and SVD from Kleinberg [24], our score based on the HITS algorithm can be construed as a variant of LowRank, in which we only consider a rank-1 approximation and use the SVD components directly. An alternative 4 score scheme AdvHits (Advanced Hits). Instead of using hub and au- thority scores, in each set, edge indicators are rewarded when they match the structure in Eq. (4) and penalised otherwise, through the reward-penalty matrix associated to M given by D = 2M − 1 = 1 −1 −1 −1 1 −1 −1 −1 −1 1 1 −1 −1 −1 −1 1 = d1 d2 d3 d4 = e1 e2 e3 e4 , where di is the ith column vector of D, and ei is the ith row vector of D. The first column/row corresponds to Pout, the second column/row to Cin, and so on. We shall iteratively update two sets of scores: (1) raw scores SRaw = [SRaw in ] which are sums of the connection-based rewards and penalties for each vertex; and (2) normalised scores SN rm = [SN rm in , CRaw out , CRaw out , PRaw ] = [PN rm ] = [PRaw , CN rm , CN rm , PN rm , SN rm , SN rm , SN rm , SRaw , SRaw , SRaw ] with 1 2 3 4 out in out in 1 2 3 SRaw i = ASN rmeT i + (cid:16) 4 (cid:16) 1 − + m n2 1 − (cid:17) m n2 (cid:17) m n2 (1 − A)SN rm(−eT i ) m n2 (1 − AT )SN rm(−di) , AT SN rmdi + (13) for i ∈ {1, . . . , 4}. The first two terms score the outgoing edge indicators and the last two terms score the incoming edge indicators. The multiplicative constants are chosen to weigh edges in each direction evenly, and to fix the contribution of non-edges to be equal to that of edges. As the scores in (13) can be negative and the scores for a given vertex may not sum to 1, we (j)}, and normalise as follows. For j ∈ {1, . . . , n} let B(j) = min{P Raw for i ∈ {1, . . . , 4} we set (j) − B(j) out (j), CRaw out (j), P Raw (j), CRaw SN rm SRaw (j) = (14) in in i i (cid:80)4 k=1 (cid:0)SRaw k (j) − B(j)(cid:1) . Thus for each vertex the scores for the four groups sum to 1. If for a given vertex, the raw scores in each of the sets are equal up to floating point error (defined as the denominator of Eq. (14) being less than an arbitrarily fixed constant (10−10)), we set the normed score in each set to 0.25. 8 We initialise and update the scores as follows. First, we assign a raw score for each vertex set combination uniformly at random from 0 to 1, which we then use to calculate the normalised scores. We then update each of the scores in turn, first updating PRaw out using SN rm, next updating SN rm using the new value of SRaw, then repeating the same procedure for each of the remaining scores in the order Cin, Cout and Pin. We repeat the procedure until convergence, which we measure by computing the largest change observed in each normalised score when we update its raw counterpart; convergence is determined if the largest change over each of the sets is less than 10−8. The general iteration can fail to converge within 1000 iterations. If the scheme has not converged after 1000 steps, we fall back to a scheme which updates the scores on each vertex in turn which often empirically removes the convergence problem with the cost of additional computational complexity. To obtain the set labels, we cluster the normalised score matrix SN rm using k-means++, and allocate each of the clusters to a named set by mapping the clusters to sets which maximises the log-likelihood as will be explained in the next subsection, Section 33.3. We call this method AdvHits. The AdvHits method may lead to large sets having a higher contribution to the score than small sets. Thus, as an alternative scoring system with score matrix SN rm, we introduce a 4 × 4 diagonal matrix FY with diagonal entries the sum of the scores for the vertices, so that (FY )ii = 1/(cid:80)n j=1 SN rm ji for i ∈ {1, . . . , 4}, and use the iteration scheme m n2 SN rmFY(di + eT i + AT SN rmFYdi − =ASN rmFYeT i ) . SRaw i (15) This iteration scheme makes the contribution from each set to a vertex score identical even for very differently sized sets. The same normalisation scheme and updating scheme as for AdvHits is then used; we call this method AdvHitsGrp. 3.3 Method class 3: Likelihood maximisation As third method we maximise the likelihood of the directed core -- periphery model Eq. (5), which is a stochastic block model with 4 blocks and our particular connection structure. For maximising the likelihood numerically we use, first, a greedy approach from [45] which we call HillClimb, and the second, a slower but potentially more accurate approach from [22] which we call MaxLike. HillClimb iteratively updates the values of p1 and p2, and the set assignments. Our implementa- tion deviates slightly from that in [45] for example in having a fixed number of iterations; see SI B. Unlike HillClimb, MaxLike does not consider a random order of vertices, but instead updates the vertices in an order which increases the likelihood the most at each step, thus giving a poten- tially more accurate (albeit slower) algorithm. The complete algorithm can be found in SI B.For multimodal or shallow likelihood surfaces the maximum likelihood algorithms may fail to detect the maximum and instead find a local optimum. Hence we use a range of starting points for the algorithms. There is a considerable difference in computational cost between HillClimb and MaxLike, with one iterate of the HillClimb taking O(m) time where m is the number of edges, while for MaxLike in sparse networks the computational complexity is O(n2 + m). A detailed discussion around the computational complexity can be found in SI B(c). 9 4 Numerical Experiments on Synthetic Data To compare the performance of the methods from Section 3, we create three benchmarks using the synthetic model in Section 2 and measure accuracy by computing the Adjusted Rand Index (ARI) [21] between the output partition of a network and the ground truth, using the implementa- tion from [37]. ARI takes values in [−1, 1], with 1 indicating a perfect match, and an expected score of approximately 0 under a given model of randomness; a detailed description is given in SI D(a). For completeness, we also compute the similarity using VOI (Variation of Information [34]) and NMI (Normalised Mutual Information [27]), and achieve qualitatively similar results, shown in SI D. As each of our new methods is specifically designed to output the structure in Eq. (4), all of these comparisons can be seen as assessing their performance gain over generic methods in detecting the directed core periphery structure. We first compare our method against a naıve classifier (Deg.), which performs k-means++ [2] clustering solely on the in- and out- degree of each vertex. To compare against other approaches, we divide our methods into three classes: fast methods (LowRank and HITS slow methods (HillClimb and MaxLike), and variable methods, namely AdvHits. We use a separate category for AdvHits as it can be fast, but in networks with non-existent or weak structure (e.g., Erdos- R´enyi random graphs) it can fall back on the single vertex update scheme described at the end of Section 3.2, which reduces the speed considerably. The methods in each of these three classes are compared to methods from the literature that have a similar speed -- quality trade-off as the method class it is being compared against. Our second comparison assesses fast methods against other methods with a similar run time. For completeness, we also compare the AdvHits method in this comparison. We assess the performance against two well-known fast approaches for directed networks, namely SaPa from [44] and DiSum from [42]. For full details of our implementation and the variants we consider see SI D(e). For brevity we only include the best performing SaPa and DiSum variant namely SaPa2, using degree- discounted symmetrisation, and DiSum3, a combined row and column clustering into four sets, using the concatenation of the left and right singular vectors. The final comparison assesses full likelihood methods. We compare to the block modelling fitting approach (GraphTool) from the graph-tool software package [39] based on the approach from [38, 40], by using a procedure that minimises the the minimum description length of the observed data directly. To make this a fair comparison we use the non-degree corrected block modelling fitting approach, and we fix the number of sets at 4, which makes this approach to equivalent to maximising the likelihood. For completeness, we also compare against AdvHits, as it has a time profile between the fast methods and the slow methods. Benchmark 1 We test our approaches using the 1-parameter model from Eq. (6), with equally- sized sets and varying the parameter p ∈ {0.5, 0.49, 0.48, . . . , 0.21} ∪ {0.195, 0.19, 0.185, . . . , 0.005}. We choose a finer discretisation step in the p-range which corresponds to a weaker planted structure, and we average over 50 network samples for each value of p. Recall that for p = 0.5 the planted structure corresponds to the idealised block structure in Eq. (4) and for p = 0 the planted structure corresponds to an Erdos-R´enyi random graph with edge probability 0.5. The performance results are shown in Table 1, giving the ARI for p = 0.4 and p = 0.1, and then for values of p between 0.05 and 0.015 with step size 0.005, in decreasing order. We graphically compare the performance of 8 of these methods in Figure 2 for n = 1000, and 10 p: Deg. Disum3 SaPa2 HITS LowRank AdvHits GraphTool HillClimb MaxLike 0.4 1.0 1.0 1.0 1.0 1.0 1.0 1.0 1.0 1.0 0.1 0.985 0.919 0.954 0.995 0.992 1.0 1.0 1.0 1.0 0.05 0.745 0.180 0.186 0.766 0.764 0.888 0.965 0.967 0.967 0.045 0.670 0.115 0.137 0.687 0.687 0.825 0.928 0.932 0.932 0.04 0.592 0.057 0.089 0.605 0.605 0.733 0.797 0.874 0.874 0.035 0.492 0.020 0.044 0.507 0.506 0.613 0.013 0.763 0.751 0.03 0.384 0.007 0.015 0.393 0.393 0.479 0 0.611 0.611 0.025 0.279 0.002 0.005 0.255 0.255 0.335 0 0.412 0.409 0.02 0.179 0.001 0.002 0.160 0.160 0.196 0 0.216 0.215 0.015 0.104 0.000 0.001 0.094 0.094 0.103 0 0.096 0.093 Table 1: ARI of the methods under comparison on Benchmark 1 for different values of p and with network size n = 1000. we further present a comparison with the case where n = 400 in SI D(b). For ease of readability HillClimb is not included in Figure 2 as Table 1 illustrates that its performance is very similar to MaxLike. We observe that in all cases, Method class 3 (likelihood maximisation) outperforms the other approaches for a large range of p. The AdvHits algorithm also achieves good performance, while taking less run time than the likelihood approaches (see SI D(c) for further details on run time). For NMI and VOI we observe similar qualitative results, see SI D. Above a certain threshold of p (roughly around p = 0.2), many approaches including the degree- based approach Deg. achieve optimal performance, indicating that in this region of the networks obtained with Benchmark 1, the degrees alone are sufficient to uncover the structure. Below this threshold, the AdvHits and likelihood approaches strongly outperform the degree-based approach, while the LowRank and HITS methods equal the performance of the degree method in some regions and outperform it in others. SaPa2 from [44] and DiSum3 from [42] are outperformed by our methods LowRank, HITS, and AdvHits. The slow likelihood-based methods MaxLike and HillClimb outperform even GraphTool which fits a general block model to the data, although the difference is less pronounced than the difference between the fast methods. Finally, we note that the performance of GraphTool collapses as p gets close to 0 (similar behaviour is observed for n = 400 see SI D(b)). Further investigation indicated that for low values of p, GraphTool often places most vertices in a single set (see SI D for further details). Benchmark 2 We use the two-parameter model from Eq. (5), again with all four sets of the same size n 4 , now the edge probabilities (p1, p2) vary the density and the strength of the core periphery structure. To this end, we vary p1, and the ratio 0 ≤ p2 = 0 corresponds to the strongest structure and p2 = 1 to the weakest structure. We generate 10 networks each with p1 p1 ∈ {0.025, 0.05, . . . , 1.0} and p2 p1 ∈ {0, 0.05, . . . , 0.95}, resulting in 820 parameter instances of (p1, p2 ). The results for n = 1000 are in Fig. 3 with a comparison to n = 400 presented in SI D(b). p1 We present the contours corresponding to an average ARI of 0.75. Due to space constraints, we only display HITS, LowRank, AdvHits and MaxLike as well as the best-performing other methods SaPa2, GraphTool and Deg. The performance of HillClimb is again very similar to that of < 1. For a given p1, p2 p1 p1 11 Figure 2: Performance on Benchmark 1 (see Eq. (6)). The ARI between the planted partition of the graph and the partition detected by each method for networks of size n = 1000. On the x axis, we vary the parameter p on a log scale. Error bars are one sample standard deviation. Figure 3: Contour plot of ARI=0.75 on Benchmark 2 (see Eq. (5)). For this plot, we calculate the average ARI over 10 networks of size n = 1000 varying p1 ∈ {0.025, 0.05, . . . , 1.0} and p2 p1 ∈ {0, 0.05, 0.1, . . . , 0.95}, and then display the contours corresponding to an average ARI of 0.75. We note that the fast methods HITS and LowRank outperform the comparisons Deg. and SaPa2, although they are hard to distinguish due to similar performance. 12 2−12−22−32−42−52−62−72−8p0.00.20.40.60.81.0ARIBenchmark1Performance(ARI)MaxLikeSaPa2Disum3HitsLowRankAdvHitsGraphToolDeg.0.20.40.60.81p10.20.40.60.8p2/p1ARI=0.75contours(n=1000)SaPa2HitsLowRankAdvHitsGraphToolDeg.MaxLike MaxLike and not shown. The same comparisons performed using VOI and NMI can be found in SI D. As observed for Benchmark 1, the full likelihood approaches outperform all other methods, with the performance of AdvHits coming close and outperforming GraphTool in certain regions. Comparing the fast methods only, again, the slower AdvHits approach outperforms all of the other fast approaches, performing almost as well as the full likelihood MaxLike method. Within the slow methods, MaxLike outperforms GraphTool, although occasionally it only finds a local maximum. The 0.9 contour ( Fig. SI 2 of SI D) shows that the performance of GraphTool is closer to that of the likelihood methods compared to the 0.75 contour. This could again be related to GraphTool often placing all vertices in the same community when the structure is weak. Benchmark 3 Benchmark 3 assesses the sensitivity of our methods to different set sizes. In the 1-parameter model from Eq. (6), fix p = 0.1 as this value is sufficiently large to see variation in performance between our approaches, but sufficiently small that most of the methods can detect the underlying structure. We then fix the size of three of the sets and vary the size of the final set. For example, to vary Pout, we fix nCin = nCout = nPin = n 4 and test performance when we let nPout ∈ {2−3 n 4}, with equivalent formulations for the other sets. 4 , 2−2 n 4 , . . . , 23 n Figure 4: ARI of all methods on Benchmark 3 with sets of different sizes (see Eq. (5)). We fix p = 0.1, the size of 3 sets at n/4 with n = 400, and vary the size (denoted as n2) of the fourth set. Error bars are one sample standard deviation. Results for n = 400 are shown in Fig. 4. The relative performance of the methods matches that of the first two synthetic experiments, with the likelihood methods performing best, followed by AdvHits, then by the faster LowRank and HITS methods, and finally by the other spectral 13 0.000.250.500.751.00ARIPoutSaPa2HitsLowRankAdvHitsGraphToolDeg.HillClimbCin0.1250.2500.5001.0002.0004.0008.000n2/(0.25n)0.000.250.500.751.00ARICout0.1250.2500.5001.0002.0004.0008.000n2/(0.25n)Pin approaches. The likelihood methods appear to be robust to set size changes. The performance of the faster methods depends on core or periphery set changes. In the periphery, smaller set sizes seem to have a minimal impact on performance, while large set sizes lead to a large decay in performance. In the core, both smaller and larger sets appear to have a significant impact. For a large core set, the fast methods outperform the AdvHits methods, as the performance of AdvHits decays much faster, and in some cases, AdvHits is even outperformed by Deg. 5 Application to real world data Next, we test our methods on three real-world data sets, namely Political Blogs (Blogs) from [1] (Section 55.1), Faculty hiring data (Faculty) from [11] (Section 55.2), and Trade data (Trade) from [17] (Section 55.3). In each case our methods find a division into four sets and we explore the identified structure using any known underlying attributes. For each data set, we first assess the consistency of the partitions both within and between each of the approaches. We compute 11 runs for each of the fast methods, 1 run for the slow methods, and then compute the within-method ARI between the resultant partitions and the ARI between methods of different types. We also compare with the structure uncovered by bow-tie [10], as discussed in Section 1. Bow-tie can allocate vertices to several sets -- there is a core set, an incoming periphery set, an outgoing periphery set and 4 additional sets corresponding to other connection patterns. Thus, we consider the ARI between the partition into 7 sets (BowTie), and the partition induced only by the core set and the in- and out-periphery sets (BowTieAdj). When computing the ARI between the partition induced by the core and periphery sets of BowTie (the partition we call BowTieAdj) with another partition S, we consider the partition induced by S on the vertex-set in BowTieAdj (and thus, by construction, the ARI between BowTieAdj and BowTie is always 1). As there is no "ground truth" core-periphery structure available for these networks, we carry out a Monte Carlo test to assess whether the detected structure could plausibly be explained as arising from random chance. To this end, we take the difference between the probability of connection within the 'L' shape (din), with that outside of the 'L' shape (dout), maximising the likelihood over the 4! = 24 ways of rearranging the sets. This statistic is used in two Monte Carlo tests, with 250 repeats each, against the following null models: (1) a directed Erdos-R´enyi (ER) model without self-loops (using the standard NetworkX implementation [19]) in which we set the number of vertices and the connection probability equal to those of the observed network, and (2), inspired in part by [4], a directed configuration model with self-loops (again using the standard NetworkX implementation [19]), which adjusts for the in- and out-degree of the vertices, collapsing multi-edges into a single edges. In AdvHits, these Monte Carlo tests often fall back to the single vertex update scheme and thus can be slow. 5.1 Political Blogs The data set, PolBlogs from [1] consists of political blogs as vertices, and directed edges from one Blog to another denoting that the first blog contains at least one link to the second blog. The data set was collected on a single day during the 2004 US presidential election. After collapsing 65 multi-edges, it contains 1490 vertices and 19090 edges. The set of blogs is divided into 758 liberal blogs and 732 conservative blogs. For the analysis in this section, we focus on the largest weakly connected component of the network, which has n = 1222 vertices and 19024 edges. 14 Figure 5: PolBlog results Left panel The ARI between the partitions uncovered by each method. For ease of comparison, negative values are set to 0. For the faster methods we compare with 11 runs and show the average similarity between all pairs of partitions whereas for the slow methods, we use a single run and thus display a blank (white) square on the corresponding diagonal blocks. To compare to bow-tie, we compare both to the partition into 7 sets and a partition formed by a subset of the vertices corresponding to the main three sets. Right panel The p-values of the Monte Carlo test on each partition against a directed ER and a directed configuration model. The first panel of Fig. 5 shows the ARI between the different approaches. We note a high within-method ARI, and a high ARI between HITS and LowRank (perhaps unsurprisingly, as both use centrality-based scores), and also a high ARI between AdvHits and AdvHitsGrp and between the likelihood methods. Furthermore, there is a low ARI between our methods and bow-tie, indicating that our methods uncover a different structure. The Monte Carlo p-values of the tests described at the beginning of this Section can be seen in Fig. 5. The HITS and LowRank methods are significant at 5% level against the directed ER null model but not against the directed configuration model, potentially indicating that the structures found are a function of the in- and out-degree distribution. It is of course possible that LowRank and HITS uncover significantly non-random structures, just that these structures do not correspond to an 'L'-shape structure. The other structures are significant at a 5% level on both tests. Noting the similarity between the likelihood methods, for brevity we restrict our discussion to AdvHits method and MaxLike. Beginning with the AdvHits method, Fig. 6 presents both a network visualisation and a matrix showing the density of edges between each pair of sets. The underlying density structure reveals an 'L'-shape, albeit a weaker connection than anticipated in Pin. Assessing whether the partitions which are found by AdvHits and MaxLike methods relate to the classification of a blog as liberal or conservative, we observe that the partitions are not just a function of political affiliation; see Fig. SI 9 in SI E for full details. Instead, similar to the division in [52], the sets may relate to the role they play in the network. Indeed, the in- and out-degree distributions in each of the sets, as shown in Fig. 7A, indicate that the sets Pout, Cin and Cout have in-and out-degrees which correspond to a core -- periphery structure. Directly comparing the AdvHits partition with the core-periphery partition, using the stochas- tic block model approach from [52], as implemented in the cpalgorithm package [25], we uncover 15 HitsLowRankAdvHitsAdvHitsGrpHillClimbMaxLikeBowTieBowTieAdjAverageARIBetweenPartitions0.00.20.40.60.81.0HitsLowRankAdvHitsAdvHtsGroupHillClimbMaxLike10−210−1100P-valueP-valuecomparisonp=0.05ERModelConfig.Model Figure 6: Structures in PolBlogs. In the left (AdvHits) and right (MaxLike) panels, we show summary network diagrams associated with the uncovered structures. In these summaries the size of each of the vertices is proportional to the number of vertices in each set, and the width of the lines is the percentage of edges that are present between the sets. The width of lines is designed to highlight the differences and is not comparable between plots. The centre panel displays the percentage of edges between each pair of blocks, allowing for easy visualisation of the 'L'-structure. Figure 7: A - Boxplot of in- and out-degree in each of the sets in AdvHits. B - Boxplot of in- and out-degrees in each of the sets in MaxLike. To visualise the in- and out-degrees on a log scale, we add 1 to the degrees. C - Confusion table between the AdvHits partition and the division into a standard core-periphery structure. D - Confusion table between the partition given by AdvHits and the partition by MaxLike. 16 AdvHits0.0020.050.0080.0010.0030.070.020.0020.0070.10.040.0050.00030.010.0010.0004PoutCinCoutPinMaxLike0.0050.080.020.0030.0090.10.030.0040.060.20.10.050.00070.0080.0030.0006100101102AdvHitsAIn-Degree+1Out-Degree+1PoutCinCoutPin100101102MaxLike.BPoutCinCoutPinPerip.CoreUndirectedCorePeriphery.PoutCinCoutPinAdvHits197121196341855880CPoutCinCoutPinMaxLike1880010419601715559413300555D the confusion table in Fig. 7C. Our method splits the previously detected core into two distinct sets which fulfil different roles, and to a lesser extent, splits the periphery in a similar way. In the case of the periphery sets, this could be the propensity of the individual site owners to link out to other content, as both periphery sets have a similar average in-degree, but differ on out-degree, a property controlled by the authors of the blog. A possible explanation for the split within the cores is that the Cin set represents blogs that are seen as authorities, and thus do not link to many other blogs (but are linked to themselves), whereas the opposite is true of those in Cout. A potentially related structure was observed in 15-block SBM from [40], in which they identify blocks that cite but are not cited, and other blocks which are highly cited either in general or by specific groups. To assess this hypothesis, an inspection of the web-address corresponding to the vertices in each set suggests that certain sets are enriched for 'blogspot' sites. A 'blogspot' site is a free blogging site that requires less expertise to set up than a full website. Indeed, while the fractions of 'blogspot' sites in Pout (0.566), Cout (0.411), and Pin (0.454) are relatively similar, the percentage in Cin is distinctly smaller at 0.180, supporting our hypothesis. Moreover, [1] provides a list of the top 20 conservative and the top 20 liberal blogs, by filtering the top ≈ 100 liberal and conservative blogs by degree, and ranking the top blogs by the number of citations of blog posts in an external index (see [1] for details). In AdvHits, 100% of these top blogs are in Cin, again supporting our hypothesis. The structure uncovered with MaxLike, shown in Fig. 6 again has an 'L'-shape structure, indicating a split into the 4 roles; compared to AdvHits, the size of Cout is greatly reduced with a much larger Pout and a slightly enlarged Cin. We first note that the likelihood of this structure is higher than that of the AdvHits method. The confusion table between this structure and the AdvHits structure in Fig. 7D suggests that most of the vertices in Cout in the AdvHits structure have moved to Pout, with a reasonably sized subset also moving to Cin. The confusion table has a small number of large values, indicating that many pairs of vertices in the same set in one partition are also in the same set in the other. This is consistent with our previous assertion that the partitions are similar (as measured by ARI). The degree patterns of each of the sets are still preserved, see Fig. 7B, although with a much larger out-degree in Cout. This split indicates a different partition of the sets into a large out-linking set consisting of 4 vertices with large out- degree, with the remaining vertices mostly moving to Pout. Furthermore, while the undirected core -- periphery structure is not visible here (see Fig. SI 10 in SI E), the confusion table indicates that the Cin set is relatively unchanged,. The 'blogspot' statistic (0.21 in Cin versus > 0.43 in all other sets) and 39 out of 40 top blogs are in Cin in this division, also support the interpretation that Cin is enriched for authorities. 5.2 Faculty Hiring In the faculty hiring network from [11], vertices are academic institutions, and a directed edge from institution i to j indicates that an academic received their PhD at i and then became faculty at j. The data set is divided by gender, faculty position, and into three fields (Business, Computer Science, and History). For brevity, we only consider the overall connection pattern in Computer Science. In [11] it is found that a large percentage of the faculty is trained by a small number of institutions, and it is suggested that there exists a core -- periphery-like structure. We apply our methodology to this data set, and find that the results from the AdvHits variants and the likelihood methods are significant at 5% under both random null models. The partitions within method class are again very similar (data not shown). For brevity, due to the similarity 17 Figure 8: Structures in Faculty uncovered by MaxLike and the AdvHits. In the left (MaxLike) and right (AdvHits) panels we show summary network diagrams associated with the uncovered structures. In these summaries the size of each of the vertices is proportional to the number of vertices in each set, the width of the lines is given by the percentage of edges that are present between the sets. The width of lines is designed to highlight the differences and is therefore not comparable between plots. The centre panel displays the percentage of edges between each pair of blocks which allowing easily visualisation of the 'L'-structure. between the partitions, we focus on the results from the MaxLike and AdvHits. The MaxLike results in Fig. 8 show a clear 'L'-shape structure, albeit with a weakly defined Pout. Inspecting the sets, Cout consists of highly-ranked institutions, including Harvard, Stanford, MIT and also a vertex that represents institutions outside of the data set. Fig. 9C shows the University ranking π obtained by [11], and the two other University rankings used in the [11], abbreviated NRC95 and USN2010, in each of the sets which are found using MaxLike. Here, the NRC95 ranking from 1995 was used because the computer science community rejected the 2010 NRC ranking for computer science as inaccurate. The NRC ranked only a subset of the institutions; all other institutions were assigned the highest NRC rank +1 = 92. The set Cout has considerably smaller ranks than the other sets, indicating that Cout is enriched for highly ranked institutions. The set Pin from MaxLike appears to represent a second tier of institutions who take academics from the schools in Cout (Fig. 8) but do not return them to the job market. This observation can again be validated by considering the rankings in [11] (Fig. 9C). The Cin set loosely fits the expected structure with a strong incoming link from Cout and a strong internal connection (Fig. 8), suggesting a different role to that of the institutions in Pin. A visual inspection of the vertices in Cin reveals that 100% of the institutions in Cin are Canadian (also explaining the lack of ranking in USN2010 (Fig. 9C)). In contrast, the proportion of Canadian universities in Pout is 11.1%; in Cout it is 2.3%, and in Pin it is 0.79%. This finding suggests that Canadian universities tend to play a structurally different role to US universities, tending to recruit faculty from other Canadian universities, as well as from the top US schools. In [11] the insularity of Canada was already noted, but without a core-periphery interpretation. Finally, Pout is weakly connected both internally and to the remainder of the network (Fig. 8). In each of the rankings (Fig. 9C), Pout has slightly lower average ranks than the other sets (with the exception Cin, due to the default/missing rankings of Canadian institutions). This could indicate 18 AdvHits0.020.010.0010.0090.070.10.040.080.10.40.40.20.040.040.0080.03PoutCinCoutPinMaxLike0.030.030.0010.0050.050.30.010.020.040.20.40.20.030.010.010.04 Figure 9: A - Boxplot of in- and out-degrees in each of the sets in MaxLike. B - Boxplot of in- and out-degrees in each of the sets in AdvHits. To visualise the out-degrees on a log scale, we add 1 to the degrees. C - Boxplot of the ranking in [11], denoted π, ranking in NRC95 and the ranking in USN2010 in each of the sets in MaxLike. D - Boxplot of the ranking in [11], the ranking in NRC95 and the ranking in USN2010 in each of the sets in AdvHits. that Pout consists of lower ranked institutions which are not strong enough to attract faculty from the larger set of institutions. The in- and out-degree distributions, (Fig. 9A), show that Pout has lower in and out-degree distributions than the other sets. Thus, an alternative hypothesis is that Pout consists of universities with smaller Computer Science departments which do not interact with In either case, the the wider network. We leave addressing this interpretation to future work. institutions in Pout do not appear to match the pattern observed in the remainder of the network and hence it is plausible to delegate them into one set. While in the AdvHits result (Fig. 8), Cout plays the same role as in the MaxLike partition, with an overlap of 42 vertices out of sets of size 43 and 45, the remaining sets appear to have a different structure. The distribution of in- and out-degrees, shown in Fig. 9B, indicates that the out-degrees of the sets tend to be much smaller than the sets uncovered by MaxLike. Further, unlike in the MaxLike case, there is a stronger ordering with respect to the academic performance of the sets (Fig. 9D). This suggests that Cin could represent a second tier of institutions which take faculty members from Cout but also take faculty members from within (the density of self-loops in Cin is 0.11, in contrast to 0.011 in Pout and 0.039 in Pin), Pin may represent a third tier of institutions which contains institutions that attract a large number of academics from Cout, while Pout may represent a fourth tier set which contains institutions that do not tend to take academics from the highest-ranked universities. 5.3 World Trade data The World Trade data set from [17] has countries as vertices and directed edges between countries representing trade. For simplicity, we focus on data from 2000 and restrict our attention to the trade in fresh, chilled and frozen bovine meats. We remove trades that do not correspond to a specific country, resulting in 720 trades for bovine meats involving 125 countries, which leads to a network density of roughly 0.046. 19 0102030In-DegreeAMaxLike.BAdvHitsPoutCinCoutPin100101102Out-Degree+1PoutCinCoutPin0100200πCMaxLikeDAdvHits050NRC95PoutCinCoutPin050100USN2010PoutCinCoutPin In the top (HITS), middle (AdvHits) and bottom Figure 10: Structures in WorldTrade. (MaxLike) panels we show summary network diagrams associated with the uncovered structures. In these summaries the size of each of the vertices is proportional to the number of vertices in each set, the width of the lines is given by the percentage of edges that are present between the sets. The width of lines is designed to highlight the differences and is therefore not comparable between plots. The centre panel displays the percentage of edges between each pair of blocks which allowing easily visualisation of the 'L'-structure. The right panel visualises the partition on a World map. 20 HitsPoutCinCoutPin0.0060.030.020.020.060.50.40.30.10.80.50.60.0060.030.020.02HitsPoutCinCoutPinAdvHitsPoutCinCoutPin0.0010.010.0040.0070.0080.040.030.030.070.40.30.30.00070.010.0050.005AdvhitsPoutCinCoutPinMaxLikePoutCinCoutPin0.00.080.010.0070.00.20.0090.020.030.40.40.20.0010.020.010.006MaxlikelihoodPoutCinCoutPin The ARIs of the partitions again show high similarity within method class (data not shown). All methods except LowRank show significant deviation from random when compared to the directed ER and directed configuration models. First, we focus on the partition uncovered by HITS shown in Fig. 10. The structure does not have a clearly visible 'L'-shape structure, but in HITS the internal 'L' density is sufficiently high to pass the significance tests. Inspecting the sets, Cout has high out-degree and often low in-degree vertices, which corresponds to large beef exporting nations, including Argentina, Australia, and Brazil. The set Cin corresponds to nations that import and export, with strong imports from the Cout set, including the UK and South Africa, whereas Pin countries are primarily importers with many vertices with out-degree 0, including Russia which strongly imports from Cout. Finally, Pout corresponds to mostly low degree vertices. AdvHits yields a different partition, producing a weak 'L'-shape structure. The Cin and Cout sets from the HITS division being combined with additional vertices to form the AdvHits' Cout set, resulting in a set with large out-degrees and a range of in-degrees. The sets Pin and Cin then are enriched for countries with strong imports from the Cout countries, with Cin having a larger average in-degree (and the set with the largest out-degree after Cout) , and Pout countries have on average a low in- and out-degree. This structure is close to a classic core -- periphery structure, with one core having a high out-degree linking to a large number of peripheral countries. Finally, MaxLike obtains a full 'L' structure; Fig. 10 shows that the geographic distribution is similar to the structure from AdvHits. There is a strong overlap between their respective Cout sets (22 shared vertices), indicating that it finds a similar core to the AdvHits. Similarly, Cin is a subset of AdvHits's Cin (overlap 4), but in MaxLike this focuses on a small set of heavily importing countries with a large in-degree and a small out-degree, which includes Japan, Oman, Russia, Saudi Arabia and United Arab Emirates. The connection pattern clearly indicates this is a set which behaves differently from the others, and we leave further investigation as future work. The periphery division is also different; Pin consists of countries with a large number of imports from Cout. In Pout, there are certain vertices with an expected structure, e.g. Ukraine, Mongolia, Lithuania and Moldova supplying Russia (Cin) and Pakistan, India and Sudan which supply the Arabian Peninsula. However, there are a number of vertices that do not match the pattern and may just be low degree vertices that are difficult to place. Overall, in our final real-world data set, we demonstrated the power of our method, uncovering three related but different core-periphery structures: a two-core structure from HITS, a single-core structure from AdvHits, and a two-core, two-periphery structure from MaxLike. 6 Conclusion and further work We provide the first comprehensive treatment of a directed discrete core -- periphery structure which is not a simple extension of bow-tie structure. The structure we introduced consists of two core sets and two periphery sets defined in an edge-direction-dependent way, each with a unique connection profile. To detect this structure algorithmically, we proposed three method classes with different speed-quality trade-offs. The fastest algorithms exploit the low-rank structure of the network and cluster the corrected degrees using k-means++, the slower set of algorithms use an iterative scheme based on the connection structure and are inspired by the HITS algorithm, and the slowest but most accurate approaches directly maximise a likelihood function. Using our synthetic model for this novel directed core -- periphery structure, we created three benchmarks, to compare our specialised approaches to four directed network clustering methods 21 that have similar speed-quality trade-offs. We found that all of our proposed approaches match or outperform clustering solely using the in- and out-degrees. Furthermore, our fast methods outperform the fast spectral comparisons from the literature, and similarly, our slow methods outperform existing slow methods. As our methods are tailored to detect the planted directed core -- periphery structure, this finding is reassuring but not surprising. Then we explored the existence of our directed core -- periphery structure in three real-world data sets, namely a political blog network, a faculty hiring network, and a world trade network.In each data set, we found at least one significant structure, when compared to random ER and configuration model graphs. In the political blogs data set, our AdvHits method, revealed a division of the classically discovered core into two independent components, a Cin core which we hypothesise consists of authorities which are highly referenced, and a Cout core which link to a large number of other blogs. We support this hypothesis by noting that Cin has a much lower percentage of 'blogspot' sites than the other set, and that Cin contains all of the top blogs identified by [1]. In the faculty hiring data set, the MaxLike partition uncovers a new structure, namely Canadian universities which have a large number of links with the top US schools, but also appear to strongly recruit from their own schools, indicating a complementary structure to the one found in [11]. In the trade data, we found different but related core -- periphery structures using each of our methods. With HITS we obtained a two-core structure which highlights strong exporters as well as those who both import and export; with AdvHits we obtain a structure which is closer to a classical core -- periphery structure, and finally with MaxLike we obtain two cores related to strong exporters and a surprising set of strong importers, a well defined Pin set, and a less well defined but coherent Pout set. Here are some avenues for future work. The trade data highlighted that some vertices simply may not fit the core -- periphery pattern, and thus following the formulation of bow-tie, it would be interesting to explore modifications to our approaches that would allow us not to place vertices if they do not match the pattern (for example, by introducing a separate set for outlier vertices). Further future work would explore graph regularisation techniques which may increase performance for sparse networks. Moreover, as detailed in SI A, other directed core -- periphery patterns are possible. Some of our methods could be adapted to also detect such core -- periphery patterns. In principle, all possible core -- periphery structures could be tested simultaneously, with an appropriate correction for multi- ple testing. Such a development should of course be motivated by a suitable data set which allows for interpretation of the results. More generally, meso-scale structures may change over time, and it would be fruitful to extend our structure and methods to include time series of networks. Acknowledgements This work was funded by EPSRC grant EP/N510129/1 at The Alan Turing Institute and Accenture Plc. In addition, we acknowledge support from COST Action CA15109. We thank Aaron Clauset for useful discussions and the authors of [49] for providing the code for the bow-tie structure. References [1] Lada A Adamic and Natalie Glance. The political blogosphere and the 2004 us election: divided they blog. In Proc. of the 3rd international workshop on Link discovery, pages 36 -- 43. ACM, 2005. 22 [2] David Arthur and Sergei Vassilvitskii. k-means++: the advantages of careful seeding. In SODA '07: Proceedings of the eighteenth annual ACM-SIAM symposium on Discrete algorithms, pages 1027 -- 1035. Society for Industrial and Applied Mathematics, 2007. [3] N. Azimi-Tafreshi, S. N. Dorogovtsev, and J. F. F. Mendes. Core organization of directed complex networks. Phys. Rev. E, 87:032815, Mar 2013. [4] Paolo Barucca and Fabrizio Lillo. Disentangling bipartite and core-periphery structure in financial networks. Chaos Soliton Fract, 88:244 -- 253, 2016. [5] Mariano Beguerisse-D´ıaz, Guillermo Garduno-Hern´andez, Borislav Vangelov, Sophia N Yali- raki, and Mauricio Barahona. Interest communities and flow roles in directed networks: the twitter network of the uk riots. J. Royal Soc. Interface, 11(101):20140940, 2014. [6] Carl Friedrich Bolz, Antonio Cuni, Maciej Fijalkowski, and Armin Rigo. Tracing the meta- level: Pypy's tracing jit compiler. In Proc. of the 4th Workshop on the Implementation, Com- pilation, Optimization of Object-Oriented Languages and Programming Systems, ICOOOLPS '09, pages 18 -- 25, NY, USA, 2009. ACM. [7] Stephen P. Borgatti and Martin G. Everett. Models of core/periphery structures. Soc. Netw., 21:375 -- 395, 1999. [8] A. Borodin, G. O. Robert, J. S. Rosenthal, and P. Tsaparas. Link analysis ranking: Algorithms, theory, and experiments. ACM Transactions on Internet Technology, 2005. [9] John P. Boyd, William J. Fitzgerald, Matthew C. Mahutga, and David A. Smith. Computing continuous core/periphery structures for social relations data with minres/svd. Soc. Netw., 32(2):125 -- 137, 2010. [10] Andrei Broder, Ravi Kumar, Farzin Maghoul, Prabhakar Raghavan, Sridhar Rajagopalan, Raymie Stata, Andrew Tomkins, and Janet Wiener. Graph structure in the web. Comput. Netw., pages 309 -- 320, 2000. [11] Aaron Clauset, Samuel Arbesman, and Daniel B Larremore. Systematic inequality and hier- archy in faculty hiring networks. Sci. Adv., 1(1):e1400005, 2015. [12] Thomas M. Cover and Joy A. Thomas. Elements of Information Theory (Wiley Series in Telecommunications and Signal Processing). Wiley-Interscience, New York, NY, USA, 2006. [13] Peter Csermely, Andr´as London, Ling-Yun Wu, and Brian Uzzi. Structure and dynamics of core/periphery networks. J. Complex Netw., 1(2):93 -- 123, 2013. [14] Mihai Cucuringu, Ioannis Koutis, Sanjay Chawla, Gary L. Miller, and Richard Peng. Simple and Scalable Constrained Clustering: a Generalized Spectral Method. AISTATS 2016, pages 445 -- 454, 2016. [15] Mihai Cucuringu, Puck Rombach, Sang Hoon Lee, and Mason A Porter. Detection of core -- periphery structure in networks using spectral methods and geodesic paths. Eur. J. Appl. Math., 27(6):846 -- 887, 2016. 23 [16] Martin G. Everett and Stephen P. Borgatti. Peripheries of cohesive subsets. Soc. Netw., 21(4):397 -- 407, 2000. [17] Robert C Feenstra, Robert E Lipsey, Haiyan Deng, Alyson C Ma, and Hengyong Mo. World trade flows: 1962-2000. Working Paper 11040, National Bureau of Economic Research, January 2005. [18] S. Fortunato. Community detection in graphs. Phys. Rep., 486:75 -- 174, 2010. [19] Aric A. Hagberg, Daniel A. Schult, and Pieter J. Swart. Exploring network structure, dy- In Proc. of the 7th Python in Science Conference namics, and function using NetworkX. (SciPy2008), pages 11 -- 15, CA USA, August 2008. [20] Petter Holme. Core-periphery organization of complex networks. Phys. Rev. E, 72:046111, Oct 2005. [21] L. Hubert and P. Arabie. Comparing partitions. J Classif, 2:193 -- 218, 1985. [22] Brian Karrer and Mark EJ Newman. Stochastic blockmodels and community structure in networks. Phys. Rev. E, 83(1):016107, 2011. [23] Jon M Kleinberg. Authoritative sources in a hyperlinked environment. Journal of the ACM (JACM), 46(5):604 -- 632, 1999. [24] Jon M. Kleinberg. Authoritative sources in a hyperlinked environment. J. ACM, 46(5):604 -- 632, September 1999. [25] Sadamori Kojaku. Cpalgorithm - python package. Github - https://github.com/skojaku/ core-periphery-detection, Dec 2018. [26] Sadamori Kojaku and Naoki Masuda. Finding multiple core-periphery pairs in networks. Phys. Rev. E, 96:052313, Nov 2017. [27] Tarald O Kvalseth. Entropy and correlation: Some comments. IEEE Transactions on Systems, Man, and Cybernetics, 17(3):517 -- 519, 1987. [28] James R Lee, Shayan Oveis Gharan, and Luca Trevisan. Multiway spectral partitioning and higher-order cheeger inequalities. J. ACM, 61(6):37, 2014. [29] S. H. Lee, M. Cucuringu, and M. A. Porter. Density-based and transport-based core-periphery structures in networks. Phys. Rev. E, 89, 2014. [30] Neng-Pin Lu. Using eigenvectors of perturbed and collapsed adjacency matrices to explore bowtie structures in directed networks. J Chin Inst Eng, 39(8):936 -- 945, 2016. [31] Hong-Wu Ma and An-Ping Zeng. The connectivity structure, giant strong component and centrality of metabolic networks. Bioinformatics, 19(11):1423 -- 1430, 2003. [32] J. B. MacQueen. Some methods for classification and analysis of multivariate observations. In L. M. Le Cam and J. Neyman, editors, Proceedings of the fifth Berkeley Symposium on Mathematical Statistics and Probability, volume 1, pages 281 -- 297. University of California Press, 1967. 24 [33] Marina Meila. Comparing clusterings -- an information based distance. J. Multivar. Anal., 98(5):873 -- 895, 2007. [34] M. Meila and J. Shi. A random walks view of spectral segmentation. In International Workshop on Artificial Intelligence and Statistics (AISTATS), 2001. [35] R. J. Mondrag´on. Network partition via a bound of the spectral radius. J. Complex Netw., 5(4):513 -- 526, 12 2016. [36] M. Newman. Networks. Oxford University Press, 2nd edition, 2018. [37] Pedregosa, F. et al. Scikit-learn: Machine learning in Python. J. Mach. Learn. Res., 12:2825 -- 2830, 2011. [38] Tiago P Peixoto. Efficient monte carlo and greedy heuristic for the inference of stochastic block models. Phys. Rev. E, 89(1):012804, 2014. [39] Tiago P. Peixoto. The graph-tool python library. Figshare, 2014. [40] Tiago P. Peixoto. Hierarchical block structures and high-resolution model selection in large networks. Phys. Rev. X, 4:011047, Mar 2014. [41] M. A. Porter, J.-P. Onnela, and P. J. Mucha. Communities in networks. Notices Amer. Math. Soc, 56:1082, 2009. [42] Karl Rohe, Tai Qin, and Bin Yu. Co-clustering directed graphs to discover asymmetries and directional communities. Proc. Natl. Acad. Sci. U.S.A., 113(45):12679 -- 12684, 2016. [43] Puck Rombach, Mason A Porter, James H Fowler, and Peter J Mucha. Core-periphery struc- ture in networks (revisited). SIAM Review, 59(3):619 -- 646, 2017. [44] Venu Satuluri and Srinivasan Parthasarathy. Symmetrizations for clustering directed graphs. In Proc. of the 14th International Conference on Extending Database Technology, pages 343 -- 354. ACM, 2011. [45] Tom A.B. Snijders and Krzysztof Nowicki. Estimation and prediction for stochastic block- models for graphs with latent block structure. J Classif, 14(1):75 -- 100, Jan 1997. [46] Wenli Tang, Liutao Zhao, Wei Liu, Yiping Liu, and Bo Yan. Recent advance on detecting core- periphery structure: a survey. CCF Transactions on Pervasive Computing and Interaction, pages 1 -- 15, 2019. [47] F. Tudisco and D. J. Higham. A nonlinear spectral method for core -- periphery detection in networks. SIMODS, 1:269 -- 292, 2019. [48] J. van Lidth de Jeude, G. Caldarelli, and T. Squartini. Detecting core-periphery structures by surprise. EPL (Europhysics Letters), 125(6):68001, apr 2019. [49] Jeroen van Lidth de Jeude, Riccardo Di Clemente, Guido Caldarelli, Fabio Saracco, and Tiziano Squartini. Reconstructing mesoscale network structures. Complexity, 2019. 25 [50] Jaewon Yang and Jure Leskovec. Structure and overlaps of communities in networks. arXiv preprint arXiv:1205.6228, 2012. [51] R. Yang, L. Zhuhadar, and O. Nasraoui. Bow-tie decomposition in directed graphs. In 14th International Conference on Information Fusion, pages 1 -- 5, July 2011. [52] Xiao Zhang, Travis Martin, and Mark EJ Newman. Identification of core-periphery structure in networks. Phys. Rev. E, 91(3):032803, 2015. 26 Supplementary Information A Alternative Definitions of Directed Core-Periphery In the main text, we proposed a novel directed core -- periphery structure, introduced methods to detect it, compared the performance of these methods on synthetic benchmarks, and explored this structure in real-world networks. While we find the extension of core -- periphery to the directed case a natural one to consider and insightful in real-world data, there are other possible choices. To better understand the space of possible directed configurations that still maintain a core -- periphery- like structure, we propose a set of criteria, and then enumerate all possible structures which satisfies these criteria. We start with a partition of the vertex set into four potentially empty sets, which we call Core 1, Core 2, Periphery 1, and Periphery 2 (we suppress the corresponding number when there is only one set of its kind). For a directed core -- periphery structure, we impose the following restrictions 1. There cannot be connections within or between periphery sets. 2. A periphery set must connect to exactly one core set. 3. Any pair of sets designated as core must connect to each other, must be connected internally, and each core set must be connected to at least one periphery set. 4. The structure can have no reciprocal edges between any two distinct blocks. We detail below the structures that satisfy the above assumptions. (i) 1 Core set and 1 periphery set We first consider the case of one core and one periphery set. As the core must connect internally, and the periphery set must connect to the core, there are two possible design matrices Core Periphery Core Periphery 1 0 1 0 Core Periphery Core Periphery 1 1 0 0 (A.16) (A.17) Directed core -- periphery structure (A.16) and (A.17) represent an asymmetric flow between the core and the periphery, as a periphery either only sends or only receives links. This can be a flow of information, such as follower-only accounts in Twitter networks, or a flow of money such as peripheral banks in inter-bank networks who sell their loans to central banks. (ii) 2 Core sets and 1 periphery set As we restrict the periphery set to connect to only one core, and each core set to connect to at least one periphery, there is no possible design matrices that satisfy these constraints. 27 (iii) 1 Core set and 2 periphery sets In order for this case to make the structure identifiable, we exclude structures that can be obtained by splitting the peripheries of our 1 core and 1 periphery structures. Under this restriction, only one configuration is possible, namely having the peripheries connect in different directions. Below is the resultant design matrix for this structure. Core Per. 1 Per. 2 1 0 0 1 1 0 0 0 0 Core Per. 1 Per. 2 (A.18) Directed core -- periphery structure (A.18) is a particular instance of the well-known bow-tie structure, essentially having a set of vertices that only send material (content, money, etc.), and a set of vertices that only receive material; there are several known real world examples, namely of the internet in [10] and in biological networks [31]. (iv) 2 Core sets and 2 periphery sets In the case of 2 core and 2 periphery sets, the cores must interconnect, and the link cannot be reciprocated, so that there is only one possible structure between the two core sets. By assumption, the periphery vertices only connect to one core set, and each core set must be connected to a periphery. Therefore, there are four possible such structures Core 1 Core 2 Per. 1 Per. 2 1 0 0 0 0 0 1 0 1 1 0 0 0 0 0 0 Core 1 Core 2 Per. 1 Per. 2 0 0 0 0 0 1 0 0 1 1 0 1 0 1 0 0 Core 1 Core 2 Per. 1 Per. 2 0 0 0 0 0 1 1 0 1 1 0 1 0 0 0 0 Core 1 Core 2 Per. 1 Per. 2 1 0 0 0 0 1 0 0 1 1 0 0 0 1 0 0 Core 1 Core 2 Per. 1 Per. 2 Core 1 Core 2 Per. 1 Per. 2 Core 1 Core 2 Per. 1 Per. 2 Core 1 Core 2 Per. 1 Per. 2 (A.19) (A.20) (A.21) (A.22) To the best of our knowledge, these structures have not been directly studied before. The directed core -- periphery structure (A.20) is essentially a bow-tie in which the core can be split into 28 two sets, one which takes the incoming connections of the periphery vertices, and the remaining core set which sends links to the additional periphery set. This could be seen as a two-step process version of the bow-tie structure, in which material is taken in, processed, and then distributed to a second set that performs a similar action. In contrast, the structure (A.19), which is the one on which the main paper focuses, is not a simple extension of the bow-tie structure due to the fact that, contrary to bow-tie, the flow in (A.19) is not uni-directional. B Stochastic Block Model Fitting In this section, we detail the algorithms for fitting a stochastic block model to the proposed struc- ture. (a) HillClimb Method The first approach is HillClimb from [45]. Our implementation is as follows. 1. Repeat the following procedure 10 times (a) Assign all vertices to a random set from Pin, Pout, Cin and Cout. (b) For a fixed number of repeats (5000 for results in the paper): i. Compute the optimal value of p1 and p2 by looking at the density in both regions of the block structure, enforcing p1 > p2. ii. Consider each vertex in a random order and place it in the set with the highest probability (using the fixed values of p1 and p2). iii. If there are no changes to the vertex sets then exit the loop. 2. Select the partition with the largest likelihood. To enforce the constraint that p1 > p2, we define p1 = max(p1, p2), and p2 = min(p1, p2). The algorithm differs slightly from [45], firstly as we have a fixed number of repeats, and secondly as we fit a likelihood with fixed set sizes and only two parameters to estimate, p1 and p2. (b) MaxLike Method We implemented MaxLike from [22] as follows. 1. Assign all vertices to a random set (CurrentPartition). 2. Calculate the likelihood of the random partition, and store it and the partition itself in BestPartition. 3. Make a list List1 of all vertices. 4. Find the vertex in List1 for which the movement to a new set will increase the likelihood the most (or decrease the least). Perform the move and remove the vertex from List1. 5. If the likelihood of the current partition is larger than BestPartition then replace Best- Partition with the current partition. 6. If List1 is not empty go to iv. 29 7. If BestPartition has improved since 3 then set CurrentPartition to BestPartition and go to 3. 8. Return BestPartition. (c) Computational Complexity There is a considerable difference in computational cost between the two likelihood approaches. In a naıve implementation, one pass of HillClimb takes on the order of O(m) to compute the parameters p1 and p2 (each edge must be considered), and O(ki) to update each vertex (querying membership of each neighbour) which overall is again O(m). As there is a fixed number of iterations, this leads to O(m) overall. MaxLike has a larger computational cost, with the naıve approach to assessing whether to change a vertex's set having a complexity of O(ki) (as before). Further, as we consider moving each unmoved vertex each time we run step 4, and step 4 is ran n times, (cid:1) times. If we store the neighbourhood structure of each iteration considers moving a vertex(cid:0)n+1 2 each vertex and update it whenever there are changes, we can reduce the complexity of exploring changing a vertices community to O(1) with the addition of O(k) when changing the structure, leading to an overall complexity of O(n2 + m). C Selection and Performance of Different Variants of the LowRank and the HITS Methods Several methodological choices were made during the development stage of HITS, LowRank, and AdvHits methods, based on their relative performance on our synthetic benchmarks, as follows. The LowRank method can be broken down into the following steps. 1. Construct a rank-2 approximation of the observed graph adjacency matrix. 2. Construct vertex scores from the low-rank approximation. 3. Cluster the vertices by applying k-means++ to the scores. For the low-rank approximation step, following [15], we considered adding a threshold to convert the low-rank approximation from a fully connected weighted directed (albeit low-rank) graph to a directed unweighted sparse graph, which may be computationally advantageous for large graphs. For the purpose of choosing whether to apply a threshold or not in the analysis shown in the main text, we compared the non-thresholded case to a threshold of 0.5. For the scoring step described in the main text, we use the scores CLR In and PLR Out. This formulation is degree-based and does not leverage other network information such as the score of the neighbours of a vertex. In this section, we consider two scoring variants for the periphery sets, the first leveraging network information and the second further exploiting the low-rank structure. For the first alternative formulation, heuristically, a vertex i should have a high Pin score if in , CLR out, PLR 1. it has in-coming edges from vertices that have high Cout scores; 2. it does not have high Cout, Cin and Pout scores. Additionally, a vertex i should have a high Pout score if 30 1. it has out-going edges to vertices that have high Cin scores; 2. it does not have high Cout, Cin and Pin scores. Combing these, we propose the following alternative scoring scheme P LR−Alt In (i) = P LR−Alt Out (i) = n(cid:88) n(cid:88) j=1,j(cid:54)=i j=1,j(cid:54)=i (cid:16) −(cid:98)AijCLR In (j) − (cid:98)AijCLR (cid:16)(cid:98)AijCLR In (j) − (cid:98)AijCLR Out(j) + (cid:98)AjiCLR Out(j) − (cid:98)AjiCLR In (j) − (cid:98)AjiCLR In (j) − (cid:98)AjiCLR (cid:17) (cid:17) Out(j) , (C.23) Out(j) . (C.24) For the second score variant, we further leverage the low-rank structure. Rather than assigning the scores based on degrees, we assign scores from the left and right singular vectors in the rank- 2 decomposition, either using the values directly or by first re-scaling by the square root of the singular values. To decide which approach to use in the main paper, we assessed the variants without thresholds and with a threshold of 0.5 for the original and alternative scoring scheme (thresholding does not impact the direct singular value schemes). We selected the approach suggested in the main paper as it has the best overall performance (although there are narrow regions with very differently-sized sets and a high network density where other approaches may perform better). Similarly to the low-rank structure, we also considered two variants of the HITS method, based on the alternative scoring in Eqs. (C.23) and (C.24). The scoring scheme we presented in the main body outperforms the alternatives on all three benchmarks. D Synthetic Benchmarks In this section, we present additional content and results which relate to our synthetic benchmarks. We first detail the ARI similarity measure used in the main document, as well as alternative similarity measures one could use (Section D(a)). Next, we present results for alternative network sizes (Section D(b)), timing results for Benchmark 1 (Section D(c)), and finally, results using alternative similarity measures (Section D(d)). (a) Similarity Measures Adjusted Rand index The Adjusted Rand Index (ARI) [21] measures the similarity between two partitions of a data set. Let V = (v1, v2, . . . , vn) be a set of vertices we wish to cluster, let X = (X1, X2, X3, X4) be a partition of V into four clusters, and let Y = (Y1, Y2, Y3, Y4) be the ideal partition. We let a be the number of vertex pairs that are placed in the same set of X and in the same set of Y ; b be the number of vertex pairs that are placed in the same set of X but in different sets of Y ; c be the number of vertex pairs that are placed in different sets of X but in the same set of Y ; d be the number of vertex pairs that are placed in different sets of X and in different sets of Y . The Adjusted Rand Index [21] is (cid:1)(a + d) − [(a + b)(a + c) + (c + d)(b + d)] (cid:0)n (cid:1)2 (cid:0)n − [(a + b)(a + c) + (c + d)(b + d)] 2 2 . ARI = 31 The Adjusted Rand Index (ARI) is bounded by ±1 with an expected value of 0. An ARI close to 1 indicates an almost perfect match between the two partitions, whereas an ARI close to -1 indicates that the agreements between two partitions is less than what is expected from random labellings, which has an ARI of 0. Normalised Mutual Information (NMI) and Variation of Information (VOI) Both of these measures are based on the concept of entropy and mutual information [12]. For a random variable X which takes values in a discrete set SX , and a random variable Y which take values in a discrete set SY [12], the entropy of X is (cid:88) a∈SX H(X) = − (cid:88) (cid:88) a∈SX b∈SY P (X = a) log(P (X = a)) and the mutual information M I(X, Y ) of X and Y is M I(X, Y ) = P (X = a, Y = b) log (cid:18) P (X = a, Y = b) P (X = a)P (Y = b) (cid:19) . The variation of information V OI(X, Y ) is defined as V OI(X, Y ) = H(X) + H(Y ) − 2M I(X, Y ), see for example [33]. Thus, if M I(X, Y ) = H(X) = H(Y ), indicating that the information in X is perfectly captured by the information in Y , V OI(X, Y ) would have a value of 0. If M I(X, Y ) = 0, then V OI(X, Y ) takes the largest possible value. Normalised mutual information N M I(X, Y ) is defined in [27] as N M I(X, Y ) = 2M I(X, Y ) H(X) + H(Y ) Again, if H(X) = H(Y ) = M I(X, Y ), then N M I(X, Y ) = 1, whereas if M I(X, Y ) = 0, then N M I(X, Y ) = 0. (b) Additional ARI Results Here we show the performance on Benchmark 1 and Benchmark 2 of our approaches for n = 400 in comparison to n = 1000 (to show the effect of different networks sizes), and additional Benchmark 2 contour plots displayed at ARI=0.9 in contrast to the ARI=0.75 (to show the effect of different contour thresholds for a given network size). The comparison for graphs of different size is shown in Fig. SI 1 (Benchmark 1); Fig. SI 2 (Benchmark 2) and Fig. SI 3 (Benchmark 3). In Benchmark 1 and 2 the results are qualitatively similar between the graph sizes with methods failing in the same order and in the same manner, although the range of values where this failure occurs shifts. This is expected as there is additional information present in larger graphs, so we would expect smaller values of p to have potentially larger effects on performance (up to detectability limits). We observe a similar effect in Benchmark 3 for n = 1000, with the increased network size (and fixed value of p = 0.1) many methods perform better over the range of block sizes, although we note that we do observe a similar decay in the performance of AdvHits. The 0.75 and 0.9 contours for ARI are shown in (Fig. SI 2). The results are broadly consistent, with similar performance for many regimes in the 0.9 contour but a much larger performance difference in the 0.75 contour. 32 Figure SI 1: Performance on Benchmark 1. The ARI between the planted partition of the graph and the partition detected by each method, with the upper, respectively lower, panel showing results for networks of size n = 1000. On the x axis, we vary the parameter p on a log scale. Error bars are one sample standard deviation. 33 0.00.20.40.60.81.0N=400ARIBenchmark1Performance(ARI)MaxLikeSaPa2Disum3HitsLowRankAdvHitsGraphToolDeg.2−12−22−32−42−52−62−72−8p0.00.20.40.60.81.0N=1000ARI Figure SI 2: Contour plot of ARI=0.75 and ARI=0.9 on Benchmark 2. For this plot, we cal- culate the average ARI over 10 networks of size 400 (left panel) and 1000 (right panel) varying p1 ∈ {0.025, 0.05, . . . , 1.0} and p2 p1 ∈ {0, 0.05, 0.1, . . . , 0.95}, and then display the contours corre- sponding to an average ARI of 0.75. We note that the fast methods HITS and LowRank out- perform the comparisons Deg. and SaPa2, although they are hard to distinguish due to similar performance. AdvHits also outperforms the fast comparisons. MaxLike has similar performance to GraphTool, but like AdvHits outperforms for larger values of p1. 34 0.20.40.60.81p10.20.40.60.8p2/p1ARI=0.75contours(n=400)0.20.40.60.81p1ARI=0.75contours(n=1000)SaPa2HitsLowRankAdvHitsGraphToolDeg.MaxLike0.20.40.60.81p10.20.40.60.8p2/p1ARI=0.9contours(n=400)0.20.40.60.81p1ARI=0.9contours(n=1000)SaPa2HitsLowRankAdvHitsGraphToolDeg.MaxLike Figure SI 3: Performance of all methods on Benchmark 3 with sets of different sizes using ARI, for n = 1000. We fix p = 0.1 and the size of 3 sets at n/4, and then measure the ability of each method to detect the sets when the size of the final set is varied. 35 0.000.250.500.751.00ARIPoutSaPa2HitsLowRankAdvHitsGraphToolDeg.HillClimbCin0.1250.2500.5001.0002.0004.0008.000n2/(0.25n)0.000.250.500.751.00ARICout0.1250.2500.5001.0002.0004.0008.000n2/(0.25n)Pin (c) Run Time On Synthetic Networks The two panels of Fig. SI 4 show the run time of each of the methods. We note that the time comparison is advisory as this calculation was performed on a Azure Virtual Machine. To mitigate the effects of hyperthreads we used half of the available vCPUs but we cannot control for other users present on the same physical hardware. Further, different approaches are implemented in different languages, with the matrix based methods (HITS, AdvHits, SaPa, DiSum, HITS, and LowRank) being implemented in Python using NumPy and SciPy vectorised matrix operations, GraphTool in C++ with Python wrapping1, and the likelihood methods are implemented in pure Python ran under cPython with the exception of MaxLike for n = 1000 which was ran under PyPy [6]. We note that when testing these methods under PyPy we obtain a ≈ 10x speed up on the cPython times. Finally, we note that the implementation of SaPa, DiSum, HITS, LowRank are relatively naıve, and could be improved, for example, by exploiting the specialised matrix construction code we use in AdvHits. We observe that the performance of many of the methods is relatively constant with respect to p, with an increase in run time when p is small. This behaviour is especially pronounced in AdvHits with comparatively fast times for the easier graphs, and slower times for the harder graphs, which is likely to be because the method falls back to the single vertex update scheme for small values of p. This is also likely to be related to the error bars (one sample standard deviation), which increase for low p in AdvHits for n = 400. We note that AdvHits would have similar time complexity to the PyPy version of HillClimb (with 10 repeats) but have substantially better time complexity than MaxLike, highlighting that the AdvHits approach is a medium speed approach in contrast to the fast approaches. (d) Benchmark Results for VOI and NMI Benchmark 1 The NMI and VOI results for Benchmark 1 can be found in Fig. SI 5. Broadly, the results are qualitative similar to the ARI results. For both NMI and VOI, SaPa2 and DiSum, are outperformed by all other methods, which is consistent with the results of ARI. Similarly AdvHits and MaxLike outperform clustering based on degree in all cases, with the HITS and LowRank methods performing at least as well as clustering based on degree. We also observe an equivalent result performance result for AdvHits, with a performance improvement over LowRank and HITS methods, but outperformed by MaxLike. We only show the results for n = 1000; the results for n = 400 are similar. We highlight the VOI results for GraphTool. It outperforms the other methods for p < 2−6 whereas ARI and NMI show precisely the opposite performance. This discrepancy may be related to the effect that placing almost all vertices into one set has on the similarity measures. Indeed, Table 2 shows the average size of the largest set in LowRank, AdvHits and GraphTool. For LowRank and AdvHits the average largest set size is close to a equal division into 4 equally-sized sets, whereas GraphTool incorrectly places most of the vertices in a single set for p < 0.04 ≈ 2−4.64. With most vertices in the GraphTool partition in one set, the entropy will be close to 0, as − log(1− ) ≈ 0, thus, as mutual information is by definition less than the entropy, the VOI becomes close to the entropy of the almost constant sequence, which is equal to − log2(0.25) = 2, a relatively high value. 1The GraphTool timings also contains the C++ graph construction, and the matrix approaches timings contain the matrix construction 36 Figure SI 4: Time taken by all methods on Benchmark 1 with the upper, respectively lower, panel showing results for networks of size n = 400, respectively n = 1000. On the x axis, we vary the parameter p, with values close to 0 more difficult to detect than higher values of p. The timing for MaxLike for n = 1000 was ran under PyPy, a faster Python interpreter, to highlight the possible speed up. 37 10−210−1100101102103N=400Time(s)Benchmark1TimeTakenMaxLikeSaPa2Disum3HitsLowRankAdvHitsGraphToolDeg.2−12−22−32−42−52−62−72−8p10−210−1100101102103N=1000Time(s) Figure SI 5: Performance on Benchmark 1. The NMI (Top Panel) and VOI (Bottom Panel) between the underlying partition of the graph and the detected partition for n = 1000. On the x axis, we vary the parameter p, with values close to 0 more difficult to detect than higher values of p. Error bars are one sample standard deviation. 38 2−12−22−32−42−52−62−72−8p0.00.20.40.60.81.0NMIBenchmark1Performance(NMI)MaxLikeSaPa2Disum3HitsLowRankAdvHitsGraphToolDeg.2−12−22−32−42−52−62−72−8p01234VOIBenchmark1Performance(VOI)MaxLikeSaPa2Disum3HitsLowRankAdvHitsGraphToolDeg. Figure SI 6: Contour plot of NMI=0.75 on the Benchmark 2. For this plot, we calculate the average NMI over 10 networks of size 1000 varying p1 ∈ {0.025, 0.05, . . . , 1.0} and p2 p1 ∈ {0, 0.05, 0.1, . . . , 0.95}, and then display the contours corresponding to an average NMI of 0.75 and 0.9. The behaviour of NMI on GraphTool can also be similarly explained, as mutual information is close to 0, NMI then also becomes close to 0. Benchmark 2 For brevity, in the main text we considered contour plots for a fixed value of ARI. In this section, we consider alternative similarity measures. We again only show the results for n = 1000; the results for n = 400 are similar. The NMI contours, displayed in Fig. SI 6, tell a broadly similar story to the ARI results (Fig. SI 2) with the methods having the same ordering and performance as we observe ARI. The VOI contours, displayed in Fig. SI 7, show broadly consistent findings but with a few small deviations. Benchmark 3 The results for Benchmark 3 be seen in Fig. SI 8. They are broadly consistent across each of the similarity measures, although there is a small deviation with the performance of AdvHits for n2 n > 2. The information theoretic measures (NMI and VOI) yield a slightly higher performance for AdvHits (in comparison to the controls) than the ARI. In both cases, the performance of AdvHits collapses in this region. (e) Performance of DiSum and SaPa variants As alluded to in the main text we consider a small number of variants of our spectral comparison methods and only display the best performing method. In this section we discuss the other variants we considered on each of our benchmarks. SaPa Variants From [44], SaPa employ a similarity measure using two different types of sym- metrisations for directed (asymmetric) adjacency matrices, namely bibiometric symmetrisation and degree discounted symmetrisation. We use them here to construct two variants of Sapa, SaPa1 and SaPa2, which we then cluster. They are defined as follows: 39 0.20.40.60.81p10.20.40.60.8p2/p1NMI=0.75contours(n=1000)SaPa2HitsLowRankAdvHitsGraphToolDeg.MaxLike n 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 p 0.050 0.045 0.040 0.035 0.030 0.025 0.020 0.015 0.010 0.005 LowRank AdvHits GraphTool 260.8 264.82 270.74 274.9 280.62 286.64 290.64 290.4 296.2 298.54 264.42 270.92 279.6 288.5 295.52 298.72 292.18 282.16 282.18 283.1 252.62 255.62 298.68 980.24 995.42 996.56 996.88 996.86 997.0 997.0 Table 2: Average (mean) size of the largest set in the detected partition in Benchmark 1. Note that the maximum achievable set size for a division into 4 non empty sets is 1000− 1− 1− 1 = 997. Figure SI 7: Contour plot of VOI=2.00 a on the Benchmark 2. For this plot, we calcu- late the average VOI over 10 networks of size 1000 varying p1 ∈ {0.025, 0.05, . . . , 1.0} and p1 ∈ {0, 0.05, 0.1, . . . , 0.95}, and then display the contours corresponding to an average VOI of 2.0. p2 40 0.20.40.60.81p10.20.40.60.8p2/p1VOI=2.0contours(n=1000)SaPa2HitsLowRankAdvHitsGraphToolDeg.MaxLike Figure SI 8: Performance of all methods on Benchmark 3 with sets of different sizes using NMI (Top Panel), and VOI (Bottom Panel). We fix p = 0.1 and the size of 3 sets at n/4, and then measure the ability of each method to detect the sets when the size of the final set is varied. 41 0.000.250.500.751.00NMIPoutSaPa2HitsLowRankAdvHitsGraphToolDeg.HillClimbCin0.1250.2500.5001.0002.0004.0008.000n2/(0.25n)0.000.250.500.751.00NMICout0.1250.2500.5001.0002.0004.0008.000n2/(0.25n)Pin01234VOIPoutSaPa2HitsLowRankAdvHitsGraphToolDeg.HillClimbCin0.1250.2500.5001.0002.0004.0008.000n2/(0.25n)01234VOICout0.1250.2500.5001.0002.0004.0008.000n2/(0.25n)Pin 1. SaPa1 - Bibiometric symmetrisation: AI AT o AD−0.5 2. SaPa2 - Degree discounted: D−0.5 I + AT I AI o + D−0.5 i AT D−0.5 i i AD−0.5 o AT D−0.5 where Di is a diagonal matrix with the in-degrees on the diagonal, Do is an diagonal matrix with the out-degrees on the diagonal, AI = A + I, where I is the identity matrix. In the original formulation of SaPa, these similarity matrices were then clustered via various clustering algorithms. Instead, we use the same kmeans++ pipeline that we leverage for other results. DiSum Variants The second fast approach, DiSum from [42], clusters the graph using the left and right singular vectors of the regularised and degree normalised adjacency matrix ((kout i + n ))−1/2Aij. The original approach in [42], performed a column and row clustering, as we m n )(kin are comparing to a full network clustering. We consider to 4 different variants of this approach: i + m 1. DiSum1 A row clustering into 4 sets, 2. DiSum2 A column clustering into 4 sets, 3. DiSum3 A combined row and column clustering into 4 sets (using the concatenation of the left and right singular vectors), 4. DiSum4 Combining a row clustering into 2 sets with a column clustering into 2 sets to obtain 4 resultant sets (with each set defined by the intersection of a pair of sets from the different clusterings). Note, we use a separate row and column clustering rather than the combined clustering in [42]. We again cluster the resulting vectors using our standard pipeline i.e. k-means++. Results Unlike in previous cases as this is a comparison method rather than computing an independent set of networks we display the method that performs best on our benchmark networks (results not shown). We observe that SaPa2 and DiSum3 outperform there counterparts on Benchmark 1; Bench- mark 2 (where the other approaches are below the threshold). In Benchmark 3 DiSum4 outperforms DiSum3, for large differences in group sizes. However, given that the DiSum3 performs reasonably and outperforms DiSum4 considerably in the Benchmark 1 and Benchmark 2, we select this as our overall DiSum method. E Political Blogs: Additional Results In this section, we present additional results on the political blogs data set. We first explore the relationship between the sets we uncover and the political division of the network. Second we relate it to undirected core-periphery structure. In the main paper we state that the partitions from AdvHits and MaxLike are related to the political division into liberals (Left) and conservative (Right) blogs, but are not purely a function of it. Figure SI 9 gives the confusion matrices between each of our divisions and the political division. We observe that with the exception of HITS, the sets divide into two roughly similarly sized sets. These sets are not in 1-1 relationship with the Left/Right division of the blogs. Hence there is evidence that the sets also relate to structural properties of the vertices. 42 Figure SI 9: Each panel shows the confusion table of the detected sets by each method and the division into left and right leaning political blogs. Colour scales are different in each plots and are designed to show the differences within a panel. Next we compare the division obtained using our approaches with the division found using the classical core -- periphery approach. The results can be seen in Fig. SI 10. We note that the split of the undirected core into Cin and Cout and the split of the undirected periphery into Pin and Pout is present in AdvHits and AdvHitsGrp. Figure SI 10: Each panel shows the confusion table of the detected sets by each method and the division into the undirected core -- periphery structure. Colour scales are different in each plot, and are designed to show the differences within a panel. 43 Left.RightPoutCinCoutPin38752677389770252AHitsLeft.Right4164711316102985551BLowRankLeft.Right73125103114104115306282CAdvHitsLeft.Right741169799117143298278DAdvHitsGrpLeft.Right140227123123102313284EHillClimbLeft.Right15023013112422303280FMaxLikePoliticalDivisionPerip.CorePoutCinCoutPin810103011530137027AHitsPerip.Core81176029291710106BLowRankPerip.Core197121196341855880CAdvHitsPerip.Core189125171502105760DAdvHitsGrpPerip.Core24911812450125907EHillClimbPerip.Core2581223252045794FMaxLikeUndirectedCorePeriphery
1904.05332
1
1904
2019-04-04T13:30:05
Community detection over a heterogeneous population of non-aligned networks
[ "cs.SI", "cs.LG", "stat.ML" ]
Clustering and community detection with multiple graphs have typically focused on aligned graphs, where there is a mapping between nodes across the graphs (e.g., multi-view, multi-layer, temporal graphs). However, there are numerous application areas with multiple graphs that are only partially aligned, or even unaligned. These graphs are often drawn from the same population, with communities of potentially different sizes that exhibit similar structure. In this paper, we develop a joint stochastic blockmodel (Joint SBM) to estimate shared communities across sets of heterogeneous non-aligned graphs. We derive an efficient spectral clustering approach to learn the parameters of the joint SBM. We evaluate the model on both synthetic and real-world datasets and show that the joint model is able to exploit cross-graph information to better estimate the communities compared to learning separate SBMs on each individual graph.
cs.SI
cs
COMMUNITY DETECTION OVER A HETEROGENEOUS POPULATION OF NON-ALIGNED NETWORKS Guilherme Gomes1, Vinayak Rao1,2, Jennifer Neville1,2 1Department of Statistics, Purdue University 2Department of Computer Science, Purdue University {gomesg, varao, neville}@purdue.edu 9 1 0 2 r p A 4 ] I S . s c [ 1 v 2 3 3 5 0 . 4 0 9 1 : v i X r a ABSTRACT Clustering and community detection with multiple graphs have typically focused on aligned graphs, where there is a mapping between nodes across the graphs (e.g., multi-view, multi-layer, temporal graphs). However, there are numerous application areas with multiple graphs that are only partially aligned, or even unaligned. These graphs are often drawn from the same population, with communities of potentially different sizes that exhibit similar structure. In this paper, we develop a joint stochastic blockmodel (Joint SBM) to estimate shared communities across sets of heterogeneous non-aligned graphs. We derive an efficient spectral clustering approach to learn the parameters of the joint SBM1. We evaluate the model on both synthetic and real-world datasets and show that the joint model is able to exploit cross-graph information to better estimate the communities compared to learning separate SBMs on each individual graph. 1 Introduction Interest in the statistical analysis of network data has grown rapidly over the last few years, with applications such as link prediction [Liben-Nowell and Kleinberg, 2007, Wang et al., 2015], collaborative filtering [Sarwar et al., 2001, Linden et al., 2003, Koren and Bell, 2015], community detection [Fortunato, 2010, Aicher et al., 2014, Newman, 2016] etc. In the area of community detection, most work has focused on single large graphs. Efforts to move beyond this to consider scenarios with multiple graphs, such as multi-view clustering [Cozzo et al., 2013], multi-layer community detection [Mucha et al., 2010, Zhou et al., 2017], and temporal clustering [Von Landesberger et al., 2016]. However, these efforts assume that the graphs are aligned, with a known correspondence or mapping between nodes in each graph. Here, the multiple graphs provide different sources of information about the same set of nodes. Applications of aligned graphs include graphs evolving over time [Peixoto, 2015, Sarkar et al., 2012, Charlin et al., 2015, Durante and Dunson, 2014]; as well as independent observations [Ginestet et al., 2017, Asta and Shalizi, 2015, Durante et al., 2015, 2018]. Such methods are not applicable to multiple non-aligned graphs, which occur in fields like biology (e.g., brain networks, fungi networks, protein networks), social media (e.g., social networks, word co-occurrences), and many others. In these settings, graph instances are often drawn from the same population, with limited, or often no, correspondence between the nodes across graphs (i.e., the nodes have similar behavior but represent different entities). Clustering and community detection methods for this scenario are relatively under-explored. While one could cluster each graph separately, pooling information across graphs can improve estimation, particularly for graphs with sparse connectivity or imbalanced community sizes. Here, we focus on the problem of community detection across a set of non-aligned graphs of varying size. Formally, we are given a set of N graphs, Ω = {A1, . . . , AN}, where the nth graph is represented by its adjacency matrix defined as An ∈ {0, 1}Vn×Vn where Vn is the set of nodes. Write En for the edges. We do not require the set Vn to be shared across different graphs, however we assume they belong to a common set of K communities. Our goal is to identify the K communities underlying Ω. For instance, consider villages represented by social graphs where nodes represent individuals in a village and edges represent relationships between them. Although the people are different in each village and the sizes of villages vary, personal characteristics may impact the propensity of having some type of relationship, e.g. a younger individual is more willing to connect with other younger individuals, or an influential person such as a priest might be expected to have more ties. Indeed, there are a vast number of factors, both observed and latent, shared among people across villages, that might influence relationship and community formation. 1Code available at github.com/kurtmaia/JointSBM. Our approach builds on the popular stochastic block model (SBM). SBMs have been studied extensively for single graph domains [Rohe et al., 2011, Lei et al., 2015, Sarkar et al., 2015], and have proven to be highly effective on real world problems [Airoldi et al., 2008, Karrer and Newman, 2011]. A simple approach to apply SBMs in our setting is to separately estimate the SBM parameters per graph, and then attempt to find a correspondence between the estimated probability structures to determine a single global community structure. We call this process Isolated SBM and show it is only reasonably accurate when each community is well represented in each graph. Moreover, the process of finding a correspondence among the estimated probabilities has O(N K 2) complexity, which is only feasible when N is small and K is very small. We propose a joint SBM model, where the key issue is to estimate a joint connectivity structure among the communities in each graph while allowing the number and sizes of clusters to vary across graphs. To estimate the parameters of the model, we show how the individual graph adjacency matrix eigendecompositions relate to the decomposition of the whole dataset Ω, and then derive an efficient spectral clustering approach to optimize the joint model. Our learning algorithm has complexity O(V K) per iteration where V is total number of nodes across graphs. Notably, our approach is more efficient than Isolated SBM because it does not need the O(N K 2) step to determine a correspondence between the separate models across graphs. We evaluate our Joint SBM on synthetic and real data, comparing the results to the Isolated SBM and an alternative approach based on clustering graph embeddings. The results show that our joint model is able to more accurately recover the community structure, particularly in scenarios where graphs are highly heterogeneous. 2 Joint SBM for multiple graphs 2.1 Single graph SBM The stochastic blockmodel (SBM) [Holland et al., 1983, Wasserman and Anderson, 1987] can be viewed as a mixture of Erdös-Rényi graphs [Erdos and Renyi, 1959], and for a single graph A with K communities, is defined by a (Vn × K) membership matrix X, and a connectivity matrix Θ ∈ [0, 1]K×K. Here X[i, k] = 1 if the i-th node belongs to community k, and equals 0 otherwise. Θ[k, l] = θkl is the probability of an edge between nodes from communities k and l. Then, a graph represented by adjacency matrix A is generated as (1) Note that aij = aji ∀i, j, and since we do not consider self-edges, aii = 0 ∀i. SBMs have traditionally been applied in settings with a single graph. Here, theoretical properties like consistency and goodness-of-fit are well understood, and efficient polynomial-time algorithms with theoretical guarantees have been proposed for learning and inference. However, there is little work for the situation with multiple observed graphs with shared statistical properties. aij ∼ Bern(XiΘX T j ) if i < j. 2.2 Multi-graph joint SBM To address this, we consider an extension of the SBM in Equation (1). Our model does not require vertices to be aligned across graphs, nor does it require different graphs to have the same number of vertices. Vertices from all graphs belong to one of shared set of groups, with membership of graph n represented by a membership matrix Xn. Edge-probabilities between nodes are determined by a global connectivity matrix Θ shared by all graphs. For notational convenience, we will refer to the set of stacked Xn matrices as the full membership matrix X, with Xni one-hot membership vector of the i-th node of graph n. The overall generative process assuming K blocks/clusters/communities is (2) where again, anij is ij-th cell of the adjacency matrix An. Note that Xn is a (Vn × K) binary matrix, and Θ is a K × K matrix of probabilities. This model can easily be extended to edges with weights (replacing the Bernoulli distribution with some other distribution) or to include covariates (e.g. through another layer of coefficients relating covariates with membership or edge probabilities). if i < j anij ∼ Bern(XniΘX T nj) 3 Inference via spectral clustering Having specified our model, we provide a spectral clustering algorithm to identify community structure and edge probabilities from graph data A1, A2, . . . , AN . 3.1 Spectral clustering for a single graph First, we recall the spectral clustering method to learn SBMs for a single graph An [von Luxburg, 2007, Lei et al., 2015]. Let Pn refer to the edge probability matrix of graph n under an SBM, where Pn = XnΘX T n (Equation (1)). Since we 2 do not consider self-loops, E[An] = Pn − diag(Pn). Further, write the eigendecomposition of Pn as Pn = UnDnU T n . Here, Un is a (Vn × K) matrix of eigenvectors related to the K largest absolute eigenvalues and Dn is a K × K diagonal matrix with the K non-zero eigenvalues of Pn. Let Gnk refer to the number of nodes that are members of n as the (cid:1)1/2 define a K × K diagonal matrix with entries(cid:112)Gnk. Define Zn DnZT cluster k, and ∆n =(cid:0)X T n Xn eigendecomposition of ∆nΘ∆n. Then UnDnU T n = Pn = XnΘX T n = Xn∆−1 n ∆nΘ∆n∆−1 n X T n = Xn∆−1 n Zn DnZT n ∆−1 n X T n . (3) Since Dn and Dn are both diagonal, and Xn∆−1 n and Zn are both orthonormal, Dn = Dn, Un = Xn∆−1 In practice, we use the observed adjacency matrix An as a proxy for Pn, and replace Un in Eqs. (3) and (4) with (cid:98)Un calculated from the eigendecomposition An = (cid:98)Un(cid:98)Dn(cid:98)U T n . Finally we note that each row of Xn has only one non-zero element, indicating which group that node belongs to. Thus, as in Lei et al. [2015], we can use k-means clustering to recover Xn and Wn = ∆−1 n Zn. (4) (cid:107)XnWn − (cid:98)Un(cid:107)2 (cid:17) (cid:16)(cid:98)Sn (cid:105)−1 diag Given a solution = arg min Xn∈MVn,K Wn∈RK×K (cid:16)(cid:99)Xn,(cid:99)Wn where (cid:98)Sn = (cid:98)∆−2 n An(cid:99)Xn(cid:98)∆−2 n (cid:99)X T estimator (cid:98)Θ in Eq. (6) is unbiased for the true Θ. See Appendix 9.2 for details of derivation and unbiasedness. from Equation (5), we can estimate Θ from the cluster memberships(cid:99)Xn as: n and (cid:98)∆2 n(cid:99)Xn. If we assume the true membership matrix X is known, then the (cid:98)Θn =(cid:98)Sn +(cid:98)∆−2 n = (cid:99)X T (cid:104)Ik −(cid:98)∆−2 (6) F n n (5) 3.2 Naive spectral clustering for multiple graphs Given multiple unaligned graphs, the procedure above can be applied to each graph, returning a set of Xn's and Θn's, one for each graph. The complexity of this is O(N φ +V K), where φ refers to the complexity of eigen decomposition on a single graph (typically O(E) for sparse graphs Pan and Chen [1999], Golub and Van Loan [2012]). However, this does not recognize that a single Θ is shared across all graphs. Estimating a global Θ from the individual Θns requires an alignment step, to determine a mapping among the Θns. The complexity of determining the alignment is O(N K 2) and is a two-stage procedure that results in loss of statistical efficiency, especially in settings with heterogenerous, imbalanced graphs. We refer to this approach as Isolated SBM. We propose a novel algorithm to get around these issues by understanding how each graph relates to the global structure. Joint spectral clustering for multiple graphs n Vn, where Vn refers to the number of nodes in An. Consider V × V block diagonal matrix A representing the whole dataset of adjacency matrices, and define an associated probability matrix P : 3.3 Let V =(cid:80) n Zn from (cid:99)Un: (cid:16)(cid:99)Xn,(cid:99)Wn (cid:17) (cid:17)  A1 ... ... 0 A = 0 . . . ... ... . . . An ... ... . . . 0 0 ... ... . . . ... ... . . . AN 0 . . . 0  , P =  P1 ... Pn1 ... PN 1 . . . P1n ... ... . . . Pn ... ... . . . PN n . . . P1N ... ... . . . PnN ... ... . . . PN  . Write the membership-probability decomposition of P as P = XΘX T , here, X is the stacked V × K matrix of the Xn's for all graphs, and Θ a K × K matrix of edge-probabilities among groups. Note that for i (cid:54)= j, Pij includes edge-probabilities between nodes in different graphs, something we cannot observe. As before, define ∆ =(cid:0)X T X(cid:1)1/2, and the eigendecomposition of P gives U DU T = P = XΘX T = X∆−1∆Θ∆∆−1X T = X∆−1Z DZT ∆−1X T , with Z DZT corresponding to the eigendecomposition of ∆Θ∆. Thus, similar to the single graph case D = D, U = X∆−1Z, (7) 3 Note that D is still a K × K diagonal matrix. Let Un∗ = Xn∗∆−1Z refer to the subset of U corresponding to the nodes in graph n, and define Xn∗ similarly. Note that Xn∗ = Xn, though Un∗ differs from Un of Eq. (4). By selecting the decomposition related to graph n, we have, Pn = (P )n,n =(cid:0)U DU T(cid:1) n,n = Un∗DU T n∗. From Eq.(3), Un∗DU T n∗ = UnDnU T n . If we let Qn := UnDn, From Eq. (7), we then have where W := ∆−1ZD. Contrast this with the single graph, which from Eq.(4), gives UnDn = Qn = Xn∆−1 If we can estimate the middle (or right) term in Eq. (10) from data, we can solve for joint community assignments: n ∆Z = Xn∗W Un∗D = QnZT (10) n ZnDn. Un∗DU T Un∗D(Xn∗∆−1Z)T Xn∆−1 n∗Xn∆−1 Un∗DZT ∆−1X T n∆−1 Un∗DU T n∗ = QnU T n n∗Un = QnU T n Un n Zn = Qn n Zn = Qn n Zn = Qn Un∗DZT ∆−1∆2 n ∆−1 N(cid:88) = arg min X∈MV ,K W ∈RK×K n (cid:16)(cid:99)X,(cid:99)W (cid:17) (cid:107)XnW − QnZT n ∆−1 n ∆Z(cid:107)2 F (8) (9) (11) (14) (15) While we can estimate Qn from the data (Equation (9)), we cannot estimate Zn or Z trivially. Instead, we will optimize an upper bound of a transformation of Equation (11). Lemma 3.1. The optimization in Eq. (11) is equivalent to N(cid:88) n=1 arg min X∈MV ,K W ∈RK×K (cid:107)an(Xn, W ) + bn(Xn)(cid:107)2 F , where (cid:32) an(Xn, W ) := (XnW − Q∗ n) ZT ∆−1∆nZn, bn(Xn) := Q∗ n ZT ∆−1∆nZn − Proof. See Appendix 9.3. Next we derive a bound for Eq. (12) using the triangle inequality and sub-multiplicative norm property. Let M be the element-wise absolute values of matrix M. Then Lemma 3.2. The following inequality holds (cid:107)an(Xn, W ) + bn(Xn)(cid:107)2 (cid:115)Vn ∆−1∆n + F ≤ (cid:107)XnW−Q∗ F γn + (cid:32) n(cid:107)2 (13) n 1 2 (cid:33)(cid:13)(cid:13)(cid:13)(cid:13)(cid:13)2 F V (cid:13)(cid:13)(cid:13)(cid:13)(cid:13)Q∗ (12) (cid:33) (cid:115)Vn V IK where γn =(cid:13)(cid:13)Z∆−1∆nZT n∆−2(cid:1) = :=(cid:101)an(Xn, W ) +(cid:101)bn(Xn) := ηn(Xn, W ) (cid:13)(cid:13)2 F = tr(cid:0)Zn∆n∆−2∆nZT K(cid:88) = tr(cid:0)∆2 n n (cid:1) Gnm G·m . Proof. See Appendix 9.4 m=1 Summary: We can now optimize the bound on Eq. (12) (cid:16)(cid:99)X,(cid:99)W (cid:17) N(cid:88) = arg min X∈MV ,K W ∈RK×K ηn(Xn, W ) The terms(cid:101)an(·) and(cid:101)bn(·) are weighted sums of squares of Qn. However, we center each Qn at the global weighted mean W in(cid:101)an(·). The term γn controls the importance of the global parameter W in each graph. Thus, γn downweights the effect of W in small graphs and in graphs with highly underrepresented communities. Intuitively, the term(cid:101)an(·) n ∆Z =(cid:112)V /VnIK, and(cid:101)bn(·) accounts for the distance between a is assigning nodes to clusters assuming ZT given graph and the global distribution of nodes over clusters. n ∆−1 n 4 Optimization: We optimize Equation (15) using a heuristic inspired by Lloyd's algorithm for k-means. This involves iterating two steps: (1) compute the means W given observations in each cluster X; (2) assign observations to clusters X given means W : 1. Compute the means: We update W by minimizing ηn(Xn, W ) for a given X, i.e.(cid:80)N 0. Note that the(cid:101)bn does not involve W so it is dropped, n (Xn(cid:99)W − Q∗ (cid:34) N(cid:88) n)γn = 0 2X T N(cid:88) (cid:99)W = n n Q∗ X T nγn n ∇W ηn(Xn, W ) = 2. Assign nodes to communities: We assign each node to the cluster that minimizes Eq. (15). Accordingly, define ωni(k) as the distance of node i to cluster k: n n X T n Xnγn (cid:35)−1 N(cid:88) (cid:13)(cid:13)(cid:13)(cid:13)(cid:13)Q∗ (cid:101)∆ni(k) =(cid:2)(∆2 − diag(Hl) + diag(Hk))(cid:3)−1/2 ×(cid:2)(∆2 ωni(k) = (cid:107)Wk − Q∗ (cid:16)(cid:101)∆2 ni(cid:107)2 tr ni(k) (cid:17) ni + V IK (cid:115)Vn (cid:33)(cid:13)(cid:13)(cid:13)(cid:13)(cid:13)2 (cid:32)(cid:101)∆ni(k) + n − diag(Hl) + diag(Hk))(cid:3)1/2 Wk is the k-th row of W and (cid:101)∆ni(k)) is the value of ∆−1∆n if node i is placed in cluster k. Precisely, say node i is currently in cluster l, then we have where Hl is a size K one-hot vector at position l. Then Xni = arg min k ωni(k) Algorithm: Algorithm 1 outlines the overall procedure for learning the Joint SBM. The complexity is O(N φ +V K). Recall that φ refers to the complexity of eigen decomposition on a single graph. Note that our derived objective does not require decomposition of the full graph A, instead decomposing each individual graph and then using the results to jointly estimate X and W . Notice that the extra O(N K 2) for alignment in the Isolated SBM is not needed here. Given the cluster assignments X, we can easily estimate the cluster edge probabilities Θ (see Eq.(6)). 4 Comparing Joint SBM to Isolated SBM n ∆−1 n ∆Z term in the definition of(cid:101)an(Xn, W ) (Eq. (13)), which, intuitively, normalizes n ∆Z ≈(cid:112)Vn−1V which Both Joint SBM and Isolated SBM use the eigen decompositions of the individual N graphs, and are closely related. The biggest difference is the ZT each individual graph eigenvector based on the distribution of nodes over the clusters in the graph. If the graphs are balanced, i.e., they have roughly the same proportion of nodes over clusters, then ZT does not depend on the cluster sizes. Lemma 4.1 formalizes this (See Appendix 9.5 for proof): Lemma 4.1. Let the pair (X, Θ) represent a joint-SBM with K communities for N graphs, where X is the stacked membership matrix over the N graphs and Θ is full rank. The size of each graph Vn may vary, but assume the graphs are balanced in expectation in terms of communities, i.e., assume the same distribution of cluster membership for all graphs: Xni iid∼ Mult(ζ) for all n ∈ [1, ..., N ] and i ∈ [1, ...,Vn]. Then, n ∆−1 (16) (17) (18) (19) (20) E(cid:2)ZT n ∆−1 n ∆Z(cid:3) =(cid:112)Vn−1V (cid:13)(cid:13)(cid:13)(cid:13)(cid:13)2Q∗ VnK V + n(cid:107)2 F n (cid:115)Vn V (cid:13)(cid:13)(cid:13)(cid:13)(cid:13)2 For cases where we expect Lemma 4.1 to be true, we have: E [ηn(Xn, W )] = (cid:107)XnW − Q∗ Now, we expect the RHS of Equation (15) to depend only on(cid:101)an(Xn, W ), since(cid:101)bn(·) no longer depends on Xn. If the graphs are also of the same size, then for each graph, the objective function of Joint SBM is equivalent to that of Isolated SBM. Lemma 4.2 formalizes this (See Appendix 9.6 for proof): F 5 Lemma 4.2. Let the pair (X, Θ) represent a joint-SBM with K communities for N graphs. If the sizes of the graphs are equal, i.e., Vn = V /N and the graphs are balanced in expectation in terms of communities, i.e., assume the same distribution of cluster membership for all graphs: Xni iid∼ Mult(ζ) for all n ∈ [1, ..., N ] and i ∈ [1, ...,Vn]. Then, E[ηn(Xn, W )] ∝ (cid:107)XnWn − (cid:98)Un(cid:107)2 F (21) Lemma 4.2 illustrates the scenario when clustering the nodes of each graph individually (Isolated) and jointly have the same solution (i.e., based on optimizing Qn). However, this is only true with respect to the node assignments for each individual graph. If we look to the global assignments, the Isolated and the Joint model are expected to be the same only up to N−1 permutations of the community labels. Thus, for a good global clustering result, the Isolated model needs an extra O(N K 2) step to realign the estimated Xns, which can also introduce additional error. If the data does not have graphs of the same size or the distribution of clusters varies across graphs, then the Isolated model will likely miss some blocks on each graph. Our joint method avoids these issues by using pooled information across the graphs to improve estimation. See Appendix 9.7 for a toy data example. Appendix 9.8 also includes a discussion of consistency. 5 Related work Community detection in graphs has seen a lot of recent attention. We focus on extensions to multiple graphs, emphasizing two relevant directions: heterogeneity across communities and nonaligned graphs. For the former, Karrer and Newman [2011] propose a degree corrected SBM to account for heterogeneity inside a community, though Gulikers et al. [2017] showed that this fails to retrieve true communities in a high heterogeneous setting. Ali and Couillet [2017] introduce a normalized Laplacian form that account for high heterogeneous scenarios, however this comes at a high computational cost. Mucha et al. [2010] work with multiplex networks for time-dependent data, in their case each edge has multiple layers (attributes) which can be viewed as multiple aligned graphs. Our work is in a different domain, we work with non aligned networks. More generally, methodology for multiple graphs can be divided into geometric Ginestet et al. [2017], Asta and Shalizi [2015] and model-based Durante et al. [2018], Duvenaud et al. [2015] approaches. The first approach seeks to characterize graphs topologically and explore hyperspace measures. Ginestet et al. [2017] introduces a geometric characterization of the network using the so-called Fréchet mean while their approaces are mathematically elegant, they are substantially less flexible than our work. The second approach aims to embed graph to a lower dimension space without oversimplifying the problem by making use of latent models. Durante et al. [2018], Gomes et al. [2018] proposed a mixture of latent space model to perform hypothesis testing on population of binary and weighted aligned graphs, respectively. On the other hand, [Duvenaud et al., 2015] worked with non-aligned graphs, Xni (cid:54)= Xn(cid:48)i, modeling node features conditioned on its neighbors. They provided a convolutional neural network approach which is invariant to node permutation. However, unlike us, their method assumes knowledge of node features Xni. Overall, the closest work to our model is from Mukherjee et al. [2017] where a similarity measure is used to align communities across graphs. In our approach, the model does not rely on a distance to compare graph communities as we cluster nodes across graphs jointly. 6 Synthetic experiments In this section, we evaluate our algorithm for the joint SBM model with synthetic data where the ground truth is known. We generate data using the following generative process: (cid:18) (cid:19) πnα ∼ Dir , anijXni, Xnj, (θkl)K,K 1 αK K, k=1,l=1 Xniπn ∼ Mult(πn), ind∼ Bern(XniΘ.X T nj) (22) For all experiments, we use K = 6 and the same Θ, shown in Figure 1 (left). We vary hyperparameters including the number of graphs N, the individual graph sizes Vn, and the heterogeneity of clusters sizes in each graph α. Recall that α ≈ 0 corresponds to a homogeneous setting (similar π across all graphs), and that as α increases the clusters become more heterogeneous. We evaluate the performance of our joint spectral clustering algorithm (JointSpec), and compare against separately run- ning spectral SBM on the individual graphs and then aligning (IsoSpec). We also include as a baseline node2vec Grover and Leskovec [2016], which embeds the nodes into a low-dimensional vector space and clusters the embeddings. For IsoSpec, we used the Blockmodels R package Leger [2016], and for node2vec we used a Python implementa- tion Grover and Leskovec [2016]. 6 First, we assess community retrieval performance and global Θ estimation for each model. We design two sets of experiments, one for each assessment objective: 1. Community retrieval(cid:99)Xn: 2. Global (cid:98)Θ: πns, i.e. the proportion of blocks for each graph per scenario; (a) Fixed α = 1. N = [5, 50, 100, 200]. For each N, Vn = [25, 50, 100, 200, 500]. Figure 1(right) shows the (b) Fixed N = 100 and Vn = 200. We generate datasets for varying values of α ∈ [0.1, 2]; (a) Fixed α = 1. N = [50, 200, 400, 600, 800, 1000]. For each N, Vn = [25, 50, 200, 500]. Algorithm 1 JointSpec SBM Vn the leading K eigenvectors and eigenvalues of An. Input N adjacency matrices An ∈ {0, 1}Vn×Vn, number of communities K and tolerance ε for n ∈ [1, ..., N ] do Compute (cid:98)Un ∈ RVn×K and (cid:98)Dn ∈ RK×K as n ← (cid:98)Un(cid:98)Dn(cid:113) V set (cid:98)Q∗ Initialize(cid:99)Xn randomly n ← (cid:99)X T n(cid:99)Xn set (cid:98)∆2 compute (cid:98)∆2 ←(cid:80)N n (cid:98)∆2 compute γn ← tr((cid:98)∆2 update (cid:99)W {Eq. (16)} end for set loss0 ← 0, loss1 ← 1 and t ← 1 while losst − losst−1 > ε do n(cid:98)∆−2) {Eq. (14)} update t ← t + 1 for n ∈ [1, ..., N ] do end for for n ∈ [1, ..., N ] do n for i ∈ [1, ...,Vn] do for k ∈ [1, ..., K] do end for end for compute ∆ni(k) {Eq. (18)} compute ωni(k) {Eq. (17)} update(cid:99)Xni ← onehot(arg mink ωni(k)) n(cid:99)Xn n ← (cid:99)X T compute (cid:98)∆2 update ηn((cid:99)Xn,(cid:99)W ) {Eq. (13)} compute (cid:98)∆2 ←(cid:80)N n (cid:98)∆2 compute losst ←(cid:80)N n ηn((cid:99)Xn,(cid:99)W ) end for n end while Figure 1: Distribution of blocks for 5, 50, 100, 200 graphs (top) and synthetic data: True connectivity matrix Θ (bottom). We measured performance both quantitatively, using Normalized Mutual Information (NMI) and Standardized Square Error (SSE), and qualitatively, by visualizing the estimated connectivity matrix for each approach. For multiple graph datasets, we measure individual graph NMIs as well as the overall NMI across all graphs, in each case, comparing the estimated membership matrices(cid:99)Xn with the ground truth Xn. To measure the quality of the estimated connectivity matrix Θ, we used the standardized square error, the square error normalized by the true variance. Thus, K(cid:88) K(cid:88) ((cid:98)θkl − θkl)2 θkl(1 − θkl) SSE = k l 7 We normalize the square error by the true variance because very high (or very low) edge probabilities have lower variances and need to be up-weighted accordingly. For good Θ estimates, we expect Eq. (23) to be close to zero. IsoSpec and node2vec are by construction nonaligned. In order to align them, we (1) rank each community on each graph based on diag(Θn), then (2) re-order the connectivity matrix and membership accordingly. (23) 100 graphs200 graphs5 graphs50 graphs0.90.80.10.10.30.010.80.90.60.10.30.010.10.60.50.30.30.010.10.10.30.40.010.010.30.30.30.010.20.010.010.010.010.010.010.1123456123456 6.1 Results Community retrieval (cid:98)Xn, fixed α = 1: Figure 2(left) shows the NMI curves for increasing number of nodes for different numbers of graphs (top row: individual NMIs, and bottom row: overall NMI). For individual NMIs, each data point records the median over the graphs and the shaded region shows the interquartile range. We see that JointSpec outperformed IsoSpec and node2vec for both overall and individual NMI. That the overall NMI for IsoSpecand node2vec is poor is unsurprising, given the two-stage alignment procedure involved. Interestingly however, they perform poorly on the individual NMIs as well. This indicates that regardless the choice of realignment, the use of only local information is not enough to accurately assign nodes to clusters in multiple graph domains, and that it is important to pool statistical information across graphs. Figure 2: (Left) Fixed α: NMI for each scenario (5, 50, 100, 200 graphs) for increasing number of nodes (25, 50, 100, 200 and 500). (Right) Fixed N = 100 and Vn = 200: NMI curves for each model for increasing heterogeneity (α). Top row: median and the interquartile range curves of the individual NMIs. Bottom row: overall NMI curves. In terms of estimating the connectivity matrix, node2vec performs worst and the JointSpec estimates are the most similar to the true connectivity. Figure 4 (top row) shows the estimated connectivity matrix for each approach for the case of 200 graphs, 500 nodes per graph. Figure 3: Standardized square error of Θ (Eq. (23)) for increasing number of graphs N, for Vn = 25, 50, 200, 500. Figure 4: Connectivity matrix estimated ((cid:98)Θ) by each approach (columns) and for each dataset (rows) (syn- thetic data, Karnataka villages, and Twitter). 8 llllllllllllllllllllllllllllllllllllllll5 graphs50 graphs100 graphs200 graphsIndividual NMIOverall NMI1002005001002005001002005001002005000.000.250.500.751.000.000.250.500.751.00llllllllllllllllllllllllll100 graphs and 200 nodesIndividual NMIOverall NMI0.00.51.01.52.00.000.250.500.751.000.000.250.500.751.00lIsoSpecJointSpecnode2vecllllllllllllllllllllllll200 nodes500 nodes25 nodes50 nodes25050075010002505007501000050100150200050100150200lIsoSpecJointSpecnode2vec0.8920.6940.1150.4980.2960.0330.6940.6250.1290.510.2950.0160.1150.1290.4680.1420.1070.0540.4980.510.1420.4370.3150.0210.2960.2950.1070.3150.2130.0220.0330.0160.0540.0210.0220.0930.9970.0020.0010.0010.0020.0010.0020.9260.0010.0030.0030.0020.0010.0010.8990.0010.0010.0010.0010.0030.0010.7810.0020.0020.0020.0030.0010.0020.4760.0010.0010.0020.0010.0020.0010.0060.7670.1540.1940.120.1540.4260.0230.020.1940.0230.330.0180.120.020.0180.0370.870.6520.4940.3580.230.1320.6520.6680.530.3850.2630.1340.4940.530.5520.4230.3170.1350.3580.3850.4230.4040.3060.1240.230.2630.3170.3060.2770.150.1320.1340.1350.1240.150.1780.2690.0010.0010.0020.0020.0010.0010.1160.0010.0010.0010.0010.0010.0010.0840.0010.0010.0010.0020.0010.0010.0580.0010.0010.0020.0010.0010.0010.0360.0010.0010.0010.0010.0010.0010.0070.9650.1470.1440.0910.1470.440.070.0470.1440.070.1530.010.0910.0470.010.060.6540.490.4060.3420.2880.2420.490.5590.4490.3830.3130.250.4060.4490.4920.3990.3290.2510.3420.3830.3990.4440.3440.2580.2880.3130.3290.3440.3760.2620.2420.250.2510.2580.2620.2940.0780000.0010.00100.0550.0010.0010.0010.00100.0010.0440.0010.0010.00100.0010.0010.0380.0010.0010.0010.0010.0010.0010.0320.0010.0010.0010.0010.0010.0010.0260.8740.0810.0570.050.0810.7030.0690.0590.0570.0690.520.0680.050.0590.0680.344JointSpecIsoSpecnode2vecSyntheticKarnatakaTwitter Community retrieval (cid:98)Xn, fixed N = 100 and Vn = 200: Here, we evaluate cluster retrieval performance as the cluster sizes became more heterogeneous (e.g. α increases). Figure 2(right) shows the NMI curves. The results suggest that IsoSpec and JointSpec have similar performance when the graphs are balanced in terms of distribution of nodes over communities (low values of α). However, the NMI curves diverge as α increases and for more heterogeneous settings (unbalanced graphs), the Joint model outperforms IsoSpec and node2vec by a large amount, both for overall and individual cluster retrieval performance. Furthermore, we consider more complex re-alignment procedures, and two additional cluster retrieval performance measures (adjusted Rand index and misclutering rate). Results are in accordance with the ones shown in Figure 2(right) in which Joint SBMoutperforms the Isolated models. Appendix 9.9 presents those results. We also investigated settings where the individual graph sizes varied over the dataset. To generate the data we used an overdispersed negative binomial distribution to sample graph sizes. The results are in Appendix 9.10. Overall, we found that varying α had more impact on cluster retrieval performance than varying the spread of graph sizes. Global (cid:98)Θ: Figure 3 shows the standardized square error (SSE) (23) for the Θ estimates. (lower values mean better estimates of the true Θ). Again, JointSpec outperforms IsoSpec and node2vec in all scenarios. Even when each graph does not have many nodes (e.g. Vn = 25), statistical pooling allows JointSpec to achieve good performance that is comparable with settings with larger nodes. These results also illustrate the consistency of our estimation scheme, with decreasing error as the number of samples increases. 7 Real world experiments We consider two datasets: a dataset of Indian villages, and a Twitter dataset from the political crisis in Brazil. Karnataka village dataset This2 consists of a household census of 75 villages in Karnataka, India. Each village is a graph, each person is a node, and edges represent if one person went to another person's house or vice versa. Overall, we have 75 graphs varying in size from 354 to 1773 nodes. Figure 5 (top) shows some demographics proportions for each village: these are highly heterogeneous. Looking at Caste, for instance, we have that most villages consist of "OBC" and "Scheduled Caste", but some have a very large proportion of people identified as "General". Religion and Mother-tongue seem to have same behavior. Overall, we expect that Lemma 4.1 will not hold for this scenario, and expect our approach to be better suited than IsoSpec. Table 1: Overall and Individual (mean and interquar- tile range) NMIs for Karnataka villages dataset. Model JointSpec IsoSpec node2vec 0.4995 [0.191, 0.789] 0.43807 [0.052, 0.744] Overall NMI 0.134 0.091 0.113 0.6126 [0.211,1] Individual NMI Table 2: Top 3 words assigned to communities by each model and each side (pro and against government) JointSpec IsoSpec K 1 2 3 4 Pro naovaitergolpe golpe dilmafica hora galera democralica sociais coxinha naonaors vai brasil povo Against foradilma forapt dilma janaiva compartilhar faltam mito elite compartilhar lulanacadeia lula vai Pro naovaitergolpe golpe foradilma turno venceu anavilarino rua april continuar dilmafica dilma forapt Against foradilma forapt dilma arte objetos apropriou rua coxinha elite impeachment brasil lulanacadeia Figure 5: Karnataka villages demographics propor- tions for Religion, Caste and Mother tongue. We consider a conservative setting of six communities (K = 6) for all models. Here, ground truth is unknown and we cannot assess the performance of the models precisely. To quantitatively measure performance, we compare the demographic variables presented earlier (religion, caste and mother-tongue) with the communities assigned using each model. Table 1 shows the NMIs computed in this setting, we can see that JointSpec outperformed the baselines on 2available at https://goo.gl/Vw66H4 9 ReligionCasteMother tongueCHRISTIANITYISLAMHINDUISMSCHEDULED TRIBEGENERALSCHEDULED CASTEOBCMALAYALAMMARATIHINDIURDUTAMILTELUGUKANNADA both the overall NMI and the Individual NMI. We see in Figure 4 (middle row) that the connectivity matrices estimated using IsoSpec and node2vec are noisy and weakly structured, making interpretation difficult. The connectivity matrix that our method estimated presents a very strong structure, where the within-community probability is very large and across-community is very low. Twitter We crawled Twitter from April 6th to May 31st 2016 to collect tweets from hashtags of 7382 users from both sides of the political crisis in Brazil. One side was for the impeachment of the former president, Dilma Rousseff, with the opposition describing the process as a coup. We constructed graphs based on the word co-occurrence matrices forming edge-links between words which were co-tweeted more than 20% of the time for a given user. Thus, networks represent users and nodes represent words. The resulting networks are somewhat homogeneous after controlling for the side the user is in. The sizes of the graphs vary from 25 to 1039 nodes. We used four communities (K = 4) in this experiment, and Figure 4 (bottom row) shows the estimated connectivity matrices. Now, on the surface, both JointSpec and IsoSpec have similar behavior, with node2vec estimating an extra cluster. Despite this superficial similarity, the words assigned to communities by the two models differ significantly. In order to assess words for each community, we split users between the two sides (pro and against government), and assign each word to its most frequent community across graphs. Table 2 shows the top three words per community per model. We colored words based on whether it is a more pro government (red), against it (blue) or neutral (black). For JointSpec, we see that community 1 has important key arguments per side such as "naovaitergolpe" (no coup) and "foradilma"(resign dilma). We also see that community 2 seems to have some stopwords such as "hora"(time) and "compartilhar" (share), and community 3 consist of aggressive and pejorative terms each side uses against the other like "elite" and "coxinha". For IsoSpec, no such inferences are made, and words do not seem to reflect a clear pattern. node2vec had the least informative clustering performance, where the top words for the different communities were all neutral. Since there is partial alignment across the Twitter graphs (i.e., words can appear as nodes in multiple graphs), we can assess the consistency of the clustering approaches by evaluating the entropy of community assignments across the graphs (per word). Although a word can be used in multiple contexts, we expect that a "good" clustering will assign words mostly to the same clusters, therefore resulting in a lower entropy. The results are in Appendix 9.11. Overall, we found that JointSpec had the lowest entropy. 8 Conclusion In this work, we consider the problem of multiple graph community detection in a heterogeneous setting. We showed that we need to jointly perform stochastic block model decompositions in order to be able to estimate a reliable global structure. We compared our methods with a two-step approach we called the Isolated SBM, and node2vec. Our method outperformed the baselines on global measures (overall NMI and SSE of the connectivity matrices), but interestingly also on local measures (individual NMI). This demonstrates that our method is more accurately able to assign nodes to clusters regardless of the choice of re-alignment procedure. Overall, the Isolated SBM does not pool global information in the inference step which indicates that it can only be used in highly homogeneous scenarios. References David Liben-Nowell and Jon Kleinberg. The link-prediction problem for social networks. journal of the Association for Information Science and Technology, 58(7):1019 -- 1031, 2007. Peng Wang, BaoWen Xu, YuRong Wu, and XiaoYu Zhou. Link prediction in social networks: the state-of-the-art. Science China Information Sciences, 58(1):1 -- 38, 2015. Badrul Sarwar, George Karypis, Joseph Konstan, and John Riedl. Item-based collaborative filtering recommendation algorithms. In Proceedings of the 10th international conference on World Wide Web, pages 285 -- 295. ACM, 2001. Greg Linden, Brent Smith, and Jeremy York. Amazon. com recommendations: Item-to-item collaborative filtering. IEEE Internet computing, 7(1):76 -- 80, 2003. Yehuda Koren and Robert Bell. Advances in collaborative filtering. In Recommender systems handbook, pages 77 -- 118. Springer, 2015. Santo Fortunato. Community detection in graphs. Physics reports, 486(3-5):75 -- 174, 2010. Christopher Aicher, Abigail Z Jacobs, and Aaron Clauset. Learning latent block structure in weighted networks. Journal of Complex Networks, 3(2):221 -- 248, 2014. MEJ Newman. Community detection in networks: Modularity optimization and maximum likelihood are equivalent. arXiv preprint arXiv:1606.02319, 2016. 10 Emanuele Cozzo, Mikko Kivelä, Manlio De Domenico, Albert Solé, Alex Arenas, Sergio Gómez, Mason A Porter, and Yamir Moreno. Clustering coefficients in multiplex networks. arXiv preprint arXiv:1307.6780, 2013. Peter J Mucha, Thomas Richardson, Kevin Macon, Mason A Porter, and Jukka-Pekka Onnela. Community structure in time-dependent, multiscale, and multiplex networks. science, 328(5980):876 -- 878, 2010. HongFang Zhou, Jin Li, JunHuai Li, FaCun Zhang, and YingAn Cui. A graph clustering method for community detection in complex networks. Physica A: Statistical Mechanics and Its Applications, 469:551 -- 562, 2017. Tatiana Von Landesberger, Felix Brodkorb, Philipp Roskosch, Natalia Andrienko, Gennady Andrienko, and Andreas Kerren. Mobilitygraphs: Visual analysis of mass mobility dynamics via spatio-temporal graphs and clustering. IEEE transactions on visualization and computer graphics, 22(1):11 -- 20, 2016. Tiago P Peixoto. Inferring the mesoscale structure of layered, edge-valued, and time-varying networks. Physical Review E, 92(4):042807, 2015. Purnamrita Sarkar, Deepayan Chakrabarti, and Michael I Jordan. Nonparametric link prediction in dynamic networks. In Proceedings of the 29th International Coference on International Conference on Machine Learning, pages 1897 -- 1904. Omnipress, 2012. Laurent Charlin, Rajesh Ranganath, James McInerney, and David M Blei. Dynamic poisson factorization. Proceedings of the 9th ACM Conference on Recommender Systems, pages 155 -- 162. ACM, 2015. In Daniele Durante and David B Dunson. Nonparametric bayes dynamic modelling of relational data. Biometrika, pages 1 -- 16, 2014. Cedric E Ginestet, Jun Li, Prakash Balachandran, Steven Rosenberg, Eric D Kolaczyk, et al. Hypothesis testing for network data in functional neuroimaging. The Annals of Applied Statistics, 11(2):725 -- 750, 2017. Dena Marie Asta and Cosma Rohilla Shalizi. Geometric network comparisons. In Proceedings of the Thirty-First Conference on Uncertainty in Artificial Intelligence, pages 102 -- 110. AUAI Press, 2015. Daniele Durante, David B Dunson, and Joshua T Vogelstein. Nonparametric bayes modeling of populations of networks. Journal of the American Statistical Association, 2015. Daniele Durante, David B Dunson, et al. Bayesian inference and testing of group differences in brain networks. Bayesian Analysis, 13(1):29 -- 58, 2018. Karl Rohe, Sourav Chatterjee, and Bin Yu. Spectral clustering and the high-dimensional stochastic blockmodel. The Annals of Statistics, pages 1878 -- 1915, 2011. Jing Lei, Alessandro Rinaldo, et al. Consistency of spectral clustering in stochastic block models. The Annals of Statistics, 43(1):215 -- 237, 2015. Purnamrita Sarkar, Peter J Bickel, et al. Role of normalization in spectral clustering for stochastic blockmodels. The Annals of Statistics, 43(3):962 -- 990, 2015. Edoardo M Airoldi, David M Blei, Stephen E Fienberg, and Eric P Xing. Mixed membership stochastic blockmodels. Journal of Machine Learning Research, 9(Sep):1981 -- 2014, 2008. Brian Karrer and Mark EJ Newman. Stochastic blockmodels and community structure in networks. Physical review E, 83(1):016107, 2011. P. W. Holland, K. B. Laskey, and S. Leinhardt. Stochastic blockmodels: Some first steps. Social Networks, 5:109 -- 137, 1983. Stanley Wasserman and Carolyn Anderson. Stochastic a posteriori blockmodels: Construction and assessment. Social networks, 9(1):1 -- 36, 1987. P Erdos and A Renyi. On random graphs i. Publ. Math. Debrecen, 6:290 -- 297, 1959. U. von Luxburg. A tutorial on spectral clustering. Statistics and Computing, 17(4):395 -- 416, 2007. Victor Y Pan and Zhao Q Chen. The complexity of the matrix eigenproblem. In Proceedings of the thirty-first annual ACM symposium on Theory of computing, pages 507 -- 516. ACM, 1999. Gene H Golub and Charles F Van Loan. Matrix computations, volume 3. JHU Press, 2012. Lennart Gulikers, Marc Lelarge, and Laurent Massoulié. A spectral method for community detection in moderately sparse degree-corrected stochastic block models. Advances in Applied Probability, 49(3):686 -- 721, 2017. Hafiz Tiomoko Ali and Romain Couillet. Improved spectral community detection in large heterogeneous networks. The Journal of Machine Learning Research, 18(1):8344 -- 8392, 2017. 11 David K Duvenaud, Dougal Maclaurin, Jorge Iparraguirre, Rafael Bombarell, Timothy Hirzel, Alán Aspuru-Guzik, and Ryan P Adams. Convolutional networks on graphs for learning molecular fingerprints. In Advances in neural information processing systems, pages 2224 -- 2232, 2015. Guilherme Gomes, Vinayak Rao, and Jennifer Neville. Multi-level hypothesis testing for populations of heterogeneous networks. In Data Mining (ICDM), 2018 IEEE 18th International Conference on Data Mining. IEEE, 2018. Soumendu Sundar Mukherjee, Purnamrita Sarkar, and Lizhen Lin. On clustering network-valued data. pages 7074 -- 7084, 2017. Aditya Grover and Jure Leskovec. node2vec: Scalable feature learning for networks. In Proceedings of the 22nd ACM SIGKDD International Conference on Knowledge Discovery and Data Mining, 2016. Jean-Benoist Leger. Blockmodels: A r-package for estimating in latent block model and stochastic block model, with various probability functions, with or without covariates. arXiv preprint arXiv:1602.07587, 2016. William M Rand. Objective criteria for the evaluation of clustering methods. Journal of the American Statistical association, 66(336):846 -- 850, 1971. 12 9 Appendix 9.1 Notations K Θ Vn V Gnk G·k An Pn Xn ∆n Un A P X ∆ U (cid:107) · (cid:107) (cid:107)M(cid:107)F (cid:107)M(cid:107)0 number of communities K × K connectivity matrix Nodes in graph n (cid:83)N (cid:83)N n=1 Vn nXn)1/2 Nodes in graph n and in community k n=1 Gnk Vn × Vn adjacency matrix of graph n Vn × Vn edge probabilities matrix of graph n Vn × K membership matrix of graph n (X(cid:48) Vn × K matrix of eigenvectors of Pn V × V block diagonal matrix of all An V × V matrix of all edge probabilities V × K of all membership matrices stacked (X(cid:48)X)1/2 V × K matrix of Uns stacked Euclidean (vector) and spectral (matrix) norm Frobenius norm of matrix M The l0-norm of matrix M Table 3: Notation 9.2 Derivation of Eq.(6) and unbiasedness Recall that the connectivity matrix Θ consists of edge probability for within and between communities. Now, say θkl is the element of Θ on the kth row l-th column. Thus, one can estimate θkl by counting the number of edges between communities k and l and dividing by the total number of possible edges. For k (cid:54)= l, the total number of possible edges is the number of nodes in k multiplied by the number of nodes in l. For a adjacency matrix An, we can generalize the estimation of the connectivity matrix using matrix notation as n(cid:99)Xn]−1(cid:99)X T If assume we know the true membership matrix (i.e. (cid:99)X = Xn), the off-diagonal elements of (cid:98)Sn in Eq. (24) above have n An(cid:99)Xn is double counting the edges within communities. Formally, incorrect in this setting, and also the term(cid:99)X T (cid:0)X T unbiased estimates, however the diagonal elements (i.e. the within community probability) are biased. More specifically, the total possible number of edges for nodes in the same communities is being assumed to have self loops which is n An(cid:99)Xn[(cid:99)X T (cid:98)Sn = [(cid:99)X T n(cid:99)Xn]−1 (cid:1) ∆−2 E(cid:104)(cid:98)Sn n diag (Pn) Xn (24) (cid:105) n (25) Here, we are using the fact that E[An] = Pn − diag (Pn). Furthermore, we can construct an unbiased estimator for Θ n = ∆−2 = Θ − ∆−2 n PnXn − X T n diag (Θ) by adding the following term to each diagonal element of (cid:98)Sn: Gnk(cid:0)Gnk (cid:1) (cid:3)−1 diag (cid:2)Ik − ∆−2 (cid:16)(cid:98)Sn (cid:17)(cid:105) =(cid:2)I − ∆−2 Now, it follows from Eq. (25) that E(cid:104) ∆−2 diag n n 2 n number of edges in cluster k (cid:17) (cid:16)(cid:98)Sn (cid:3) diag(Θ) where Gnk is the number of nodes in community k. For all k, we have Eq.(26) in matrix notation as (26) (27) (28) 13 Using Eqs.(24) and (27), we get the expression in Eq.(6). And using Eq. (25) and (28), we have (cid:105) E(cid:104)(cid:98)Θn  θkl(1−θkl) (cid:17) (cid:16)(cid:98)Θn We also have that GnkGnl , θkk(1−θkk) (Gnk 2 ) where Gnk is the number of nodes of graph n in cluster k. Var = 9.3 Proof of Lemma 3.1 Proof From Equation (10), and since Xn = Xn∗, we have: = Θ off-diagonal elements , diagonal elements n ∆Z n ∆−1 0 = XnW − QnZT = XnW ZT ∆−1∆nZn − Qn = XnW ZT ∆−1∆nZn − Qn = XnW ZT ∆−1∆nZn − Q∗ n (cid:115)Vn V IK (cid:115) V (cid:115)Vn Vn V IK (cid:32) (29) (30) (cid:115)Vn V IK = XnW ZT ∆−1∆nZn − Q∗ nZT ∆−1∆nZn + Q∗ nZT ∆−1∆nZn − Q∗ (cid:33) (cid:115)Vn n = (XnW − Q∗ n) ZT ∆−1∆nZn + Q∗ (cid:113) V V IK Vn. Recall that Qn corresponds to the data from a single graph. Q∗ ZT ∆−1∆nZn − n n := Qn where Q∗ based on the relative number of nodes in the graph. From this we can transform Eq. (11) to n is then a weighted version, N(cid:88) n=1 arg min X∈MV ,K W ∈RK×K (cid:107)an(Xn, W ) + bn(Xn)(cid:107)2 F . an(Xn, W ) := (XnW − Q∗ n) ZT ∆−1∆nZn bn(Xn) := Q∗ n ZT ∆−1∆nZn − (cid:33) (cid:115)Vn V IK (cid:32) where 9.4 Proof of Lemma 3.2 Proof 1 2 (cid:107)an(Xn, W ) + bn(Xn)(cid:107)2 F ≤ (cid:107)an(Xn, W )(cid:107)2 n(cid:107)2 ≤ (cid:107)XnW−Q∗ n(cid:107)2 = (cid:107)XnW−Q∗ F ≤ (cid:107)XnW−Q∗ n(cid:107)2 = (cid:107)XnW−Q∗ n(cid:107)2 F + (cid:107)bn(Xn)(cid:107)2 nZT ∆−1∆nZn − Q∗ n (cid:13)(cid:13)2 F F γn + F + (cid:107)bn(Xn)(cid:107)2 (cid:13)(cid:13)ZT ∆−1∆nZn (cid:13)(cid:13)(cid:13)(cid:13)(cid:13)Q∗ (cid:13)(cid:13)(cid:13)(cid:13)(cid:13)Q∗ (cid:13)(cid:13)(cid:13)(cid:13)(cid:13)Q∗ n F γn + F γn + n ∆−1∆n + Q∗ n (cid:32) ∆−1∆n + F V (cid:115)Vn (cid:115)Vn (cid:13)(cid:13)(cid:13)(cid:13)(cid:13)2 (cid:115)Vn (cid:33)(cid:13)(cid:13)(cid:13)(cid:13)(cid:13)2 V V F F (cid:13)(cid:13)(cid:13)(cid:13)(cid:13)2 F (31) 14 Recall that Gnk is the set of nodes from n that are in cluster k, and G.k is the set of nodes from all graphs in cluster k. The last inequality (13) uses the fact that Z and Zn are orthogonal matrices, we demonstrate why the following inequality holds: n(cid:107)2 nZT ∆−1∆nZn − Q∗ n ∆−1∆n + Q∗ n (cid:115)Vn ≤ (cid:107)XnW−Q∗ n(cid:107)2 n First, we drop what is constant on both sides of the inequality first term on both sides of the inequality. V Rewriting LHS of Eq. (33) using trace operator, we have nZT ∆−1∆nZn − Q∗ n where n n F F m=1 ≤ V F γn + (cid:13)(cid:13)(cid:13)(cid:13)(cid:13)2 Gnm G·m . (cid:115)Vn n ∆−1∆n + Q∗ n (cid:13)(cid:13)(cid:13)(cid:13)(cid:13)Q∗ (cid:115)Vn :=(cid:101)an(Xn, W ) +(cid:101)bn(Xn) := ηn(Xn, W ) (cid:13)(cid:13)2 γn =(cid:13)(cid:13)Z∆−1∆nZT F = tr(cid:0)Zn∆n∆−2∆nZT (cid:1) K(cid:88) = tr(cid:0)∆2 n∆−2(cid:1) = (cid:115)Vn (cid:13)(cid:13)(cid:13)(cid:13)(cid:13)2 (cid:115)Vn (cid:13)(cid:13)(cid:13)(cid:13)(cid:13)Q∗ (cid:13)(cid:13)(cid:13)(cid:13)(cid:13)2 = tr(cid:0)∆2 nZT(cid:1) (cid:115)Vn (cid:1) − V tr(cid:0)Q∗T (cid:13)(cid:13)(cid:13)(cid:13)(cid:13)2 (cid:115)Vn (cid:13)(cid:13)(cid:13)(cid:13)(cid:13)2 (cid:115)Vn n(cid:1) + 2 V tr(cid:0)∆n∆−1Q∗T n(cid:1) (cid:115)Vn n(cid:1) +(cid:13)(cid:13)Q∗ n(cid:1) + tr(cid:0)∆2 V tr(cid:0)∆n∆−1Q∗T nZT(cid:1) ≥ tr(cid:0)∆2 V tr(cid:0)Q∗T nZT ∆−1∆nZn n(cid:1) =2 n(cid:1) + n∆−2ZQ∗T n∆−2ZQ∗T n∆−2Q∗T (cid:1) + n Q∗ n Q∗ n Q∗ n Q∗ n Q∗ n Q∗ n Q∗ n Q∗ n Q∗ V tr(cid:0)Q∗T Vn Vn V V V = F F F n n ∆n∆−1ZQ∗T F γn + (cid:107)XnW−Q∗ nZT ∆−1∆nZn − Q∗ (cid:13)(cid:13)(cid:13)(cid:13)(cid:13)Q∗ (cid:13)(cid:13)(cid:13)(cid:13)(cid:13)Q∗ (cid:13)(cid:13)(cid:13)(cid:13)(cid:13)Q∗ (cid:115)Vn V tr(cid:0)ZT The RHS is given by(cid:13)(cid:13)(cid:13)(cid:13)(cid:13)Q∗ = tr(cid:0)∆2 (cid:115)Vn V tr(cid:0)∆n∆−1Q∗T − 2 n n Q∗ n ∆−1∆n + Q∗ n n∆−2Q∗T (32) (cid:13)(cid:13)(cid:13)(cid:13)(cid:13)2 F V n Q∗ n (33) (cid:1) (34) (35) n∆−1(cid:13)(cid:13)2 F n∆1 Finally, the inequality in Eq. (33) holds because the difference between the RHS and the LHS is positive. Given Z is orthonormal, we have i Xni = diag(X T 9.5 Proof of Lemma 4.1 Proof For graph n, the vector of counts of nodes in each cluster has expected value given by E(cid:104)(cid:80)Vn Assuming the same distribution of the nodes over cluster for all graphs, E(cid:104)(cid:80)N (cid:80)Vn = Vnζ. = V ζ. We know that i Xni = diag(X T X) = diag(∆2). Defining αn = Vn/V for all n ∈ [1, ..., N ], we have Note that if all graphs have the same size, Vn, then αn = N−1. Furthermore, using the eigendecomposition on both sides, we have Thus, Zn = Z ⇐⇒ Dn = αnD. Finally, n Xn) = diag(∆2 (cid:80)Vn αnE [∆Θ∆] i Xni i Xni (cid:105) (cid:105) √ √ √ αn αn E [∆nΘ∆n] = n) and(cid:80)V (cid:3) = E(cid:2)ZnDnZT n ∆Z(cid:3) = E(cid:104) E(cid:2)ZT = E(cid:104) n ∆−1 αnE(cid:2)ZDZT(cid:3)√ ZT(cid:16) n ∆−1(cid:17) (cid:105) α−1/2 α−1/2 n ZT Z ∆Z = α−1/2 (cid:105) n n n 15 9.6 Proof of Lemma 4.2 Proof By Lemma 4.1, where Q∗ E[ηn(Xn, W )] ∝ (cid:107)XnWn − (cid:98)Un(cid:107)2 V Vn = UnD n = Qn Vn V F E[ηn(Xn, W )] ∝ (cid:107)XnW − Q∗ V Vn = UnD. Given Vn V = 1 n(cid:107)2 F VnK V N and dropping all constants across graphs, we have 9.7 Toy data example As an example to illustrate the effect of ZT n ∆Z on the individual eigendecomposition, consider three graphs, where each graph is a village, nodes represent individuals and edges represent relationships between them. Assume that individuals are clustered in four different blocks based on their personalities, which reflects how they form relationships. Figure 6(left) shows the connectivity matrix based on those personalities. Also, consider that each village has its own distribution of people over the clusters, as shown, for instance, in Figure 6 (right). n ∆−1 Figure 6: Toy data connectivity matrix (left) and dis- tribution of blocks per village (right). Now, using the adjacency matrix eigendecomposition for each village An = (cid:98)Un(cid:98)Dn(cid:98)U T a proxy for Qn. Since (cid:98)Un(cid:98)Dn(cid:98)U T n , we have (cid:98)Qn = (cid:98)Un(cid:98)Dn as n for Tn = −Un, we consider (cid:98)Qn instead. Figure 7 (left) shows the Figure 7: Original and transformed eigenvectors n = (cid:98)Tn(cid:98)Dn(cid:98)T T two largest absolute eigenvectors of each adjacency matrix. Each block has a different center of mass depending on which village (graph) it is in. This is due the fact that villages have completely different distribution of nodes over the blocks. Therefore, sharing information across villages is fundamental not only to assign underrepresented nodes to the correct block, but also to map the blocks across villages. Using our proposed transformation given in Equation (10), we obtain the results shown on Figure 7 (right). We re-scale and rotate the eigenvectors in order to have an embedding of the nodes that is closer to the global eigendecomposition. Therefore, using any clustering algorithm one can correctly recover the membership for nodes across the three villages. 9.8 Consistency The global parameter Θ is central in order to understand Multi-graph settings. It not only gives an overall summary of how nodes connect based on their communities, but Θ also has the role to link all graphs. In other words, a reliable estimate of Θ means we can predict edges between nodes in different graphs with confidence. Here, we discuss the asymptotic behavior of Θ in Multi-graph joint SBM as N → ∞. And, we show that the estimator (cid:98)Θ = N−1(cid:80) n (cid:98)Θn in membership matrix of all graphs stacked and Θ is full rank. Write ν ≤ minn Vn. Now if assume ((cid:99)W ,(cid:99)X) is the optimal solution of Eq. 11 then (cid:98)Θ converge to Θ in probability Eq. (36). If we also assume(cid:99)Xn = Xn then (cid:98)Θ converge Eq. (6) converge to the global Θ almost surely for when we know the true membership. Lemma 9.1 (below) formalizes these statements. Lemma 9.1. Let the pair (X, Θ) parametrize a SBM with K communities for N graphs where X contains the to Θ almost surely Eq. (37). ν→∞;N→∞(cid:98)Θ P→ Θ lim (37) Proof Eq.(36) follows directly from the fact that An converge in probability to Pn for large Vn, Theorem 5.2 Lei et al. [2015]. Eq.(37) follows from Eq. (29), we know that E[(cid:98)Θn] = Θ. Thus, using Kolmogorov-Khintchine strong law of large numbers, (cid:98)Θ → Θ almost surely for large N. (36) N→∞(cid:98)Θ a.s.→ Θ lim 16 0.90.10.10.010.10.80.50.010.10.50.50.010.010.010.010.11234Village1Village2Village31234llllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllOriginal eigenvectorsTransformed eigenvectors0.000.020.040.06−100100510150.000.050.100.15lVillage1Village2Village3llll1234 accordingly. In this case, V ar((cid:98)Θ) =(cid:80)N Eq. (37) is only true in the Multi-graph joint case. In the Isolated setting, we need to re-align the memberships across graphs which adds an extra layer of complexity. For instance, assume the re-alignment procedure consists on (1) rank each community on each graph based on diag(Θn), then (2) re-order the connectivity matrix and membership n V ar(Θn) → ∞, unless we assume graph size to be large, i.e. ν → ∞ where ν ≤ minn Vn. Nevertheless, this gives weak consistency at most. In fact, this is true for any realignment procedure whose performance is a function of graph size. Figure 1 in the Synthetic experiments shows that the Joint model estimates Θ well even for small graph settings which is not true for Isolated models. 9.9 Additional re-alignment procedures and cluster retrieval performance measures Here, we assess the performance of IsoSpec using more complex re-alignment procedures (Iso2 and Iso3), we compare them with the one we used in the main body of the paper (Iso1). We also include adjusted rand index (ARI) [Rand, 1971] and misclutering rate (MCR) measures which are often used to evaluate cluster performance when ground truth is known. Now, we describe the re-alignment procedures: • Iso1 (used in the main body of the paper) 1. Rank diag(θn) 2. Re-order Xn and θn accordingly. • Iso2 1. Cluster the centers Wn across graphs 2. Re-assign nodes to clusters based on the center of the centers. • Iso3 1. Search over all permutation to make all Wn closest possible from each other 2. Re-order Xn and θn accordingly. We compute ARI, MCR and NMI for different re-alignment procedure for increasing heterogeneity the same synthetic data presented in 2(right). In order to make these additional experiments comparable with 2(right), we also include results for Joint SBM. Figure 8: Fixed N = 100 and Vn = 200: Cluster retrieval performance curves for each measure (ARI,MCR and NMI) for each model for increasing heterogeneity (α). Top row: median and the interquartile range curves of the individual graphs performance. Bottom row: overall curves. Figure 8 shows that ARI and MCR have similar results of NMI for the Joint and Iso1. In terms of the additional re-alignment procedures, Iso2 seems to outperform all other methods for the Individual case if the focus is on ARI. However, it does not have a good performance using other measures, and the reason is due to the fact that Iso2 tends to accumulate nodes in lower number of clusters, i.e. << K. In terms of the Overall curves, the Joint SBMoutperforms all the baselines for heterogeneous settings as it was expected. 17 lllllllllllllllllllllllllllllllllllllllARIMCRNMIlllllllllllllllllllllllllllllllllllllllIndividualOverall0.00.51.01.52.00.00.51.01.52.00.00.51.01.52.00.000.250.500.751.000.000.250.500.751.00lJointIso1Iso2Iso3 9.10 Synthetic data experiment for varying graphs sizes Here, we aim to assess cluster retrieval performance in settings where the graphs have different sizes. We used Vn iid∼ N B(µ, r) to sample the size of each graph, where µ is the mean and r the dispersion parameter. We fixed µ = 200 and we vary r ∈ [1, 10]. Lower values of r mean more variability in graph size distribution. We also consider K ; and 2) heterogeneous α = 1. Figure 9 shows the curves for each model in two main scenario: 1) homogeneous α = 1 each scenario. For the heterogeneous scenario it is clear that the JointSpec outperform the baselines. Also, NMI curves look flat for increasing r on both scenarios (homogeneous and heterogeneous) which suggests that the distribution of nodes over clusters (controlled by α) is more detrimental for cluster retrieval than the size of the graphs. Figure 9: NMI curves over r where r is the disper- sion parameter in Vn iid∼ N B(µ, r) for homogeneous (α = 1/K) and heterogeneous (α = 1) scenarios Figure 10: Entropy distribution of the words per model (left) and pairwise entropy difference between models for each word (right). 9.11 Assessment of community assignments in Twitter We also compute the entropy of the community assignment per words across graphs. We expect the community of the words to be consistent across graphs, therefore a lower entropy. We found that the Joint model had the lowest entropy overall, Figure 10 shows the results. Also, we include a pairwise distribution of the difference of the entropies which shows that JointSpec had the lowest entropy for the majority of the words. 18 llllllllllllalpha=1/Kalpha=1510152051015200.000.250.500.751.00lIsoSpecJointSpecnode2veclllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllEntropy distributionPairwise differenceIsoSpecJointSpecnode2vecJointSpec − IsoSpecJointSpec − node2vecIsoSpec − node2vec−101
1304.7984
1
1304
2013-04-30T13:17:44
GeoDBLP: Geo-Tagging DBLP for Mining the Sociology of Computer Science
[ "cs.SI", "cs.DL", "physics.soc-ph" ]
Many collective human activities have been shown to exhibit universal patterns. However, the possibility of universal patterns across timing events of researcher migration has barely been explored at global scale. Here, we show that timing events of migration within different countries exhibit remarkable similarities. Specifically, we look at the distribution governing the data of researcher migration inferred from the web. Compiling the data in itself represents a significant advance in the field of quantitative analysis of migration patterns. Official and commercial records are often access restricted, incompatible between countries, and especially not registered across researchers. Instead, we introduce GeoDBLP where we propagate geographical seed locations retrieved from the web across the DBLP database of 1,080,958 authors and 1,894,758 papers. But perhaps more important is that we are able to find statistical patterns and create models that explain the migration of researchers. For instance, we show that the science job market can be treated as a Poisson process with individual propensities to migrate following a log-normal distribution over the researcher's career stage. That is, although jobs enter the market constantly, researchers are generally not "memoryless" but have to care greatly about their next move. The propensity to make k>1 migrations, however, follows a gamma distribution suggesting that migration at later career stages is "memoryless". This aligns well but actually goes beyond scientometric models typically postulated based on small case studies. On a very large, transnational scale, we establish the first general regularities that should have major implications on strategies for education and research worldwide.
cs.SI
cs
GeoDBLP: Geo-Tagging DBLP for Mining the Sociology of Computer Science Fabian Hadiji1,2 Kristian Kersting1,2 Christian Bauckhage1,2 Babak Ahmadi2 1University of Bonn, Germany 2Fraunhofer IAIS, Germany {firstname.lastname}@iais.fraunhofer.de Abstract Many collective human activities have been shown to exhibit uni- versal patterns. However, the possibility of universal patterns across timing events of researcher migration has barely been explored at global scale. Here, we show that timing events of migration within different countries exhibit remarkable similarities. Specifically, we look at the distribution governing the data of researcher migration inferred from the web. Compiling the data in itself represents a significant advance in the field of quantitative analysis of migration patterns. Of- ficial and commercial records are often access restricted, incompati- ble between countries, and especially not registered across researchers. Instead, we introduce GeoDBLP where we propagate geographical seed locations retrieved from the web across the DBLP database of 1,080,958 authors and 1,894,758 papers. But perhaps more important is that we are able to find statistical patterns and create models that explain the migration of researchers. For instance, we show that the science job market can be treated as a Poisson process with individual propensities to migrate following a log-normal distribution over the researcher's career stage. That is, although jobs enter the market con- stantly, researchers are generally not "memoryless" but have to care greatly about their next move. The propensity to make k > 1 migra- tions, however, follows a gamma distribution suggesting that migration at later career stages is "memoryless". This aligns well but actually goes beyond scientometric models typically postulated based on small case studies. On a very large, transnational scale, we establish the first general regularities that should have major implications on strategies for education and research worldwide. 1 1 Introduction Over the last years, many collective human activities have been shown to exhibit universal patterns, see e.g. [34, 21, 8, 2, 6, 12, 18, 11, 5, 17, 10, 31, 3] among others. However, the possibility of universal patterns across timing events of researcher migration -- the event of transfer from one residential location to another by a researcher -- has barely been explored at global scale. This is surprising since education and science is, and has always been international. For instance, according to the UNESCO Institute for Statistics, the global number of foreign students pursuing tertiary education abroad increased from 1.6 million in 1999 to 2.8 million in 20081. As the UN notes [30], "there has been an expansion of arrangements whereby universi- ties from high-income countries either partner with universities in developing countries or establish branch campuses there. Governments have supported or encouraged these arrangements, hoping to improve training opportuni- ties for their citizens in the region and to attract qualified foreign students." Likewise, science thrives on the free exchange of findings and methods, and ultimately of the researchers themselves, as noted by the German Council of Science and Humanities [9]. The European Union even defined the free movement of knowledge in Europe as the "fifth fundamental freedom" 2. Similarly, the US National Science Foundation argues that "international high-skill migration is likely to have a positive effect on global incentives for human capital investment. It increases the opportunities for highly skilled workers both by providing the option to search for a job across borders and by encouraging the growth of new knowledge" [25]. Generally, due to glob- alization and rapidly increasing international competition, today's scientific, social and ecological challenges can only be met on a global scale both in education and science, and are accompanied by political and economic in- terests. Thus, research on scientist's migration and understanding it, play key roles in the future development of most computer science departments, research institutes, companies and nations, especially if fertility continues to decline globally [16]. But can we provide decision makers and analysts with statistical regularities of migration? Are there any statistical patterns 1United Nations Education, Scientific and Cultural Organization, Data extract (Paris, 2011), accessed on 19 April 2011 at: http://stats.uis.unesco.org/unesco/ TableViewer 2Council of the European Union (2008a), p. 5: "In order to become a truly modern and competitive economy, and building on the work carried out on the future of science and technology and on the modernization of universities, Member States and the EU must remove barriers to the free movement of knowledge by creating a 'fifth freedom' ..." 2 at all? These questions were the seed that grew into the present report. On first sight, reasons to migrate are manifold and complex: political stability and freedom of science, family influences such as long distance relationships and oversea relatives, and personal preferences such as exploration, climate, improved career, better working conditions, among others. Despite this complex web of interactions, we show in this paper that the timing events of migration within different countries exhibit remarkable simple but strong and similar regularities. Specifically, we look at the distribution governing the data of researcher migration inferred from the web. Compiling the data in itself represents a significant advance in the field of quantitative analysis of migration patterns. Although, efforts to produce comparable and reliable statistics are underway, estimates of researcher flows are inexistent, out- dated, or largely inconsistent, for most countries. Moreover, official (NSF, EU, DFG, etc.) and commercial (ISI, Springer, Google, AuthorMapper, Ar- netMinder) records are often access restricted and especially not registered across researchers. On top of it, these information sources are often highly noisy. Luckily, bibliographic sites on the Internet such as DBLP are publicly accessible and contain data for millions of publications. Papers are written virtually everywhere in the scientific world, and the affiliations of authors tracked over time could be used as proxy for migration. Unfortunately, many if not most of the prominent bibliographic sites such as DBLP do not pro- vide affiliation information. Instead, we have to infer this information. To do so, we extracted the geographical locations -- the cities -- for a few seed author-paper-pairs and then propagated them across the DBLP social net- work of more than one million authors and almost two million papers. We refer to this new dataset as GeoDBLP, DBLP augmented with geo-tags. GeoDBLP is the basis for our statistical analysis and has city-tags for most of the 5,033,018 paper-author-pairs in DBLP. Specifically, as partly shown in Fig. 1, we present the first strong regularities for researcher migration in computer science: • (R1) A specific researcher's propensity to migrate, that means to make the next move, follows a log-normal distribution. That is, researchers are generally not "memoryless" but have to care greatly about their next move. This is plausible due to the dominating early career re- searchers with non-permanent positions. This regularity of timing events is remarkably stable and similar within different continents and countries across the globe. • (R2) The propensity to make k > 1 migrations, however, follows a 3 Figure 1: We infer from the WWW the first strong regularities of tim- ing events in the migration of computer scientists. Due to the many early stage careers, with non-permanent contracts, a specific scientist's propen- sity to make the next move follows a log-normal distribution (left). For larger numbers of moves, i.e., for senior scientists this turns into a gamma distribution due to permanent positions (left-middle); migration becomes memoryless. The circulation of expertise, i.e., the time until a researcher returns to the country of her first publication follows a gamma distribution (middle-right). Returning is also memoryless. The inter-city migration fre- quency distribution, however, follows a power-law (right). That is, cities with a high exchange of researchers will even exchange more researchers in the future. These regularities should have major implications on strategies for research across the world. gamma distribution suggesting that migration at later career stages is "memoryless". That is, researchers have to care less about their next move since the majority of positions are permanent in later career stages. • Since jobs enter the market all the time, R1 and R2 together suggest that the job market can be treated as a Poisson-log-normal process. • (R3) The brain circulation, i.e., the time until a researcher returns to the country of her first publication, follows a gamma distribution. That is, returning is also memoryless. Researchers cannot plan to return but rather have to pick up opportunities as they arrive. • (R4) The inter-city migration frequency follows a power-law. That is, cities with a high exchange of researchers will exchange even more researchers in the future. So, investments into migration pay off. • Statistical patterns: Link analysis of the author-migration graph can discover additional statistical patterns such as (SP1) migration sinks, sources and incubators, as well as (SP2) the hottest migration cities. 4 10203040Years0.000.050.100.150.200.25p(x)fitdata100101Years10−610−510−410−310−210−1100p(x)datafit510152025303540Years0.000.020.040.060.080.10p(x)fitdata100101Years10−510−410−310−210−1p(x)datafit510152025303540Years0.000.020.040.060.080.100.12p(x)fitdata100101Years10−610−510−410−310−210−1100p(x)datafit102Frequency10−710−610−510−410−310−210−1p(x)datafit These results validate and go beyond migration models based on small case studies at a very large, transnational scale. Ultimately, they can provide forecasts of (re-)migration which can help decision makers who seek actively the migration and the return of their researchers to reach better decisions regarding the timing of their efforts. Already Zipf [34] investigated inter-city migration. He analyzed so called gravity models. These models incorporated terms measuring the masses of each origin and destination and the distance between them and were cali- brated statistically using log-linear regression techniques. Over the years, several modifications and alternatives have been postulated, see e.g. [6, 27] and the references in there. Steward [28] reviewed the Poisson-log-normal model for bibliometric/scientometric distributions, i.e., to characterize the productivity of scientists. Sums of Poisson processes and other Poisson regression models as well as ordinary-least-squares have actually a long tra- dition within migration research, see [29, 24] for recent overviews. All of these approaches, however, have considered small scale data only [24] and have not considered researcher migration in computer science. To the best of our knowledge, the only large-scale migration study was recently pre- sented by Zagheni and Weber [32], analyzing a large-scale e-mail datasets to estimate international migration rates, but not specific to computer scien- tists. Moreover, they have not presented any statistical regularities nor dealt with missing information. Indeed, as already mentioned, other collective hu- man activities have been the subject of extensive and large-scale planetary mining. Prominent examples are mobility patterns drawn from communica- tion [18, 13] and web services [22], as well as mining blog dynamics [10] and social ties [31]. Our methods and findings complement these results by high- lighting the value of using the World Wide Web together with data mining to deal with missing information as a world-wide lens onto researcher migra- tion, enabling the analyst to develop global strategies for research migration and to inform the public debate. We proceed as follows. We start by discussing the harvesting of our data in detail. Then, we will describe how we made use of multi-label propagation to fill in missing information. Before concluding, we will present our statistical migration models and patterns. 2 Mining the Data from the Web Bibliographic sites on the Internet such as DBLP are publicly accessible and contain millions of data records on publications. Papers are written 5 (a) Publications per year (b) Authors per year Figure 2: Statistics of the DBLP dump: The number of publications (2a) and authors (2b) per year. As one can see, DBLP has been growing constantly over the past decades from 1970 until 2010. virtually everywhere in the scientific world, and the affiliations of authors tracked over time could be used as proxy for migration. Unfortunately, many if not most of the prominent bibliographic sites such as DBLP do not provide affiliation information. Instead we have to infer this information. In this section, we will detail the mining of our data. The goal was to tag every of the over 5 million author-paper-pairs in our database with an affiliation. The data collection method utilized an open-source information extraction methodology, namely DBLP, ACM Digital Library, Google's Geocoding API and large-scale multi-label propagation. 2.1 Harvesting the Data We used DBLP3 as a starting point. DBLP is a large index of computer science publications that also offers a manual best-effort entity disambigua- tion [19]. We used an XML-dump from February 2012 which contained 1,894,758 publications written by 1,080,958 authors. Fig. 2 shows the num- ber of publications and authors per year from this dump. As one can see, the number of computer scientists as well as the productivity have been growing enormously over the past decades. Unfortunately, DBLP does not provide affiliation information for the authors over the years. This informa- tion, however, is required in order to develop migration models using author affiliations as proxy. Specifically, we aim to infer geo-tags of the more than 5 million unknown author-paper-pairs. Luckily, there are other information sources on the web that contain such 3http://dblp.uni-trier.de/ 6 197019751980198519901995200020052010Year020000400006000080000100000120000140000160000180000NumberofPublications197019751980198519901995200020052010Year050000100000150000200000250000300000AuthorsPerYear information. One of these systems is the ACM Digital Library4. Unfortu- nately, ACM DL does not allow a full download of the data. Consequently, we retrieved the affiliation information of only a few papers from ACM DL which we then had to match with our DBLP dump. This resulted in affil- iation information for 479,258 of all author-paper-pairs. In order to fill in the missing information, we resorted to data mining techniques. To do so, however, we have to be a little bit more careful. First, the names of the af- filiations in ACM DL are not in canonical form which results in a very large set of affiliation candidates. More precisely, the DBLP dump enhanced with the initial affiliations from ACM DL contained 159,068 different affiliation names in total. Secondly, although we have now partial affiliation infor- mation, we still lack exact geo-information of the organizations to identify cities, countries, and continents. Many of the affiliation names may contain a reference to the city or country but these pieces of information are not trivial to extract from the raw strings. Additionally, we want to have lati- tude and longitude values to enable further analysis and visualization. For example, latitude and longitude data would allow one to calculate exact dis- tances between collaborators. This geo-location issue can easily be resolved using Google's Geocoding API5. Just querying the API using the retrieved affiliation names resulted in geo-locations for 117,942 of the 159,068 strings. The remaining gap primarily rises from the fact that the Google API does not find geo-locations for all the retrieved affiliation strings. This is essen- tially because the strings contain information not related to the geo-location such as departments, e-mail addresses, among others. In any case, as our empirical results will show, this resulted in enough information to propagate the seed affiliations and in turn the geo-locations across the DBLP network of authors and papers. 2.2 Inferring Missing Data Before we infer the missing author-paper-pairs, we revise our obtained affil- iation data. To further increase the quality of our harvested affiliations, we hypothesized that there are actually not that many relevant organizations in Computer Science and these names need to get de-duplicated. This hypoth- esis is confirmed by services such as MS Academic Search6 which currently lists only 13,276 organizations compared to our 150k+ names. Since, we now have the geo-locations for many of the affiliation strings, we can use 4http://dl.acm.org/ 5https://developers.google.com/maps/documentation/geocoding/ 6http://academic.research.microsoft.com/ 7 Id A 1 1 2 2 2 3 1,2 4 5 1 2 6 1 7 8 2 Y 2000 2000 2001 2002 2002 2003 2004 2004 Aff Aff* g b r r,r r r r g g b r ?,? ? r r g Figure 3: Example database. this information for a simple entity resolution which helps resolving this is- sue. More precisely, we clustered affiliations together for which the retrieved city coincide resulting in 4,254 distinct cities7. The city-based entity resolution resulted in a dataset with approximately 10% of the author-paper-pairs being geo-tagged. Based on these known geo-locations, we will now fill in the missing ones. To do so, we essentially employ Label Propagation [4, 33] (LP), a semi-supervised learning algorithm, to propagate the known cities to the unknown author-paper-pairs based on the similarity between the pairs. LP works on a graph based formulation of the problem and propagates node labels along the edges. We define the LP graph as an undirected graph G = (V, E) with nodes V and edges E. We have a node in V for every author-paper-pair that we want to label with a city. Every edge eij ∈ E between two nodes i and j contains a weight wij that is proportional to the similarity of the nodes. We will now explain in detail when two nodes are connected by an edge and how the weight wij for that edge is set. Intuitively, the weight of an edge is proportional to the similarity of the nodes and we define the similarity of two nodes based on relations such as co-authorship between the authors associated with the nodes. Only those nodes are connected via an edge where wij > 0. Specifically, in order to define the edges, we considered the following functions over the set of nodes that return facts about the nodes: author(i), paper(i), and year(i). For example, author(i) essentially "returns" the author of an author-paper node. Based on these functions, we can now define logic based rules that add a rule-specific weight λk to every matching edge eij. Initially, we set all weights wij to zero. The first rule, wij+ = λ1 if paper(i) = paper(j) 7Indeed, this approach does not distinguishing multiple affiliations per cities such as MIT and Harvard. However, it is simple and effective, and -- as our empirical results show -- the resolution is sufficient to establish strong regularities in the timing events. 8 1936 2000 2001 2002 2003 2004 2012 A1 A2 1 2 3 R3 R3 R3 R3 6 R2 4 5 R1 4 7 8 (a) The graph for city propagation (b) Completed Data Figure 4: City Propagation: Missing geo-tags from the example database (see 3) are estimated by propagating the known cities/geo-locations across the network of authors and papers. The graph for propagating the informa- tion (a) is constructed as follows. For each author A and paper Id there is a node. Two nodes are connected if they are written by the same author in the same or subsequent years or if two researchers co-author them. The colors of nodes indicate known cities and white nodes indicate unknown lo- cations. As one can see (b), this significantly improves the content of our database. The number of geo-tagged author-paper-pairs increased signifi- cantly, showing the publication activities across the world. (Best viewed in color adds a weight between two nodes if the nodes belong to two authors that co-author the paper associated with nodes i and j. The second rule, wij+ = λ2 if author(i) = author(j) ∧ year(i) = year(j) adds a weight whenever two nodes corresponds to different publications by the same author in the same year. Finally, wij+ = λ3 if author(i) = author(j) ∧ year(i) = year(j + 1) fires when the nodes belong to two publications of the same author but written in subsequent years. This construction process is depicted in Fig. 4a for the example publication database in Fig. 3. The example database is missing the affiliation information for papers 4 and 5 which is denoted by the "?" in the "Aff"-column. Based on the constructed graph, we can now build a symmetric (n × n) similarity matrix W that is used as input to LP. Essentially, LP performs the following matrix-matrix-multiplication until convergence: Y t+1 = W · Y t , where Y t is the labels matrix. In Y t, row i corresponds to a distribution over the possible labels for a node i. In Y 0, we set a cell Yij to 1 if we know 9 Figure 5: Most productive research cities in the world. The diameter is proportional to the number of publications. that node i has label j. All other cells are set to 0. After every iteration, a push-back phase clamps the rows of the known nodes in Y t to their original distribution as in Y 0. This operation is performed until convergence or a maximum number of iterations has been reached. At convergence, the labels of the unknown nodes are read off the labels matrix, i.e. the label of node i is given by yi = arg max0≤j≤n−1 Yij . In our context, we call this City Propagation (CP), that is we run LP on the graph, constructed based on logical rules, to get a distribution over the possible cities for every unlabeled node. Although the implementation of CP is just a simple matrix-matrix- multiplication, this already becomes challenging with n around five million. While the similarity matrix W is very sparse, the labels matrix Y becomes denser with every iteration. Resulting in an almost pure dense matrix if the graph was completely connected. With 4k+ labels, the labels matrix already requires more than 160GB with 64bit float numbers. Fortunately, one can easily split the labels matrix into chunks and do the multiplications separately. However, we still require an efficient implementation for multi- plying a sparse-matrix with a dense-matrix. We implemented CP with the help of LAMA8, a very efficient linear algebra library. We ran CP for 100 iterations and determined the maximizing label for every unlabeled node. We used λ1 = 1, λ2 = 3, and λ3 = 2 as weights. They had been found using a grid search on a small subset of the data. After running CP, GeoDBLP contains 4,318,206 geo-tagged author-paper-pairs. Looking at the last column in our running example in Fig. 3, we see that CP fills the unknown cities, i.e. labels the missing affiliations for papers 4 and 5. The effect of running CP on our initial dataset is shown in Fig. 4b. One can see that the worldwide productivity increases significantly. The 8http://www.libama.org/ 10 1936 2000 2001 2002 2003 2004 2012 A1 A2 1 2 4 5 3 4 6 7 8 Propensity kth Move Propensity Inter-Arrival Time Waiting Time t2 2 s2 2 t(cid:48) 3 t2 1 t(cid:48) 1 t(cid:48) 2 s(cid:48) 2 Figure 6: Individual propensities and (inter-)arrival times illustrated for the two researchers A1 and A2 of our running example. A researchers's propensity (shown only for A2) is her probability of migrating. The kth move propensities are her probability of making k > 1 moves. This should not be confused with the (inter-)arrival times of the job market, i.e., of the overall Poisson process. Every node denotes a publication and the node colors denote different affiliations, i.e. there are three affiliations here: green, red, and blue. From this, we can read off migration: A1 moves from green to red, A2 moves from blue to red and from red to green. (Best viewed in color) geo-locations of publications alone can already reveal interesting insights such as the most productive research cities in the world, see Fig. 5. The main focus of the paper, however, is the timing of migration. 3 Sketching Migration Unfortunately, we cannot directly observe the event of transfer from one res- idential location resp. institution to another by a researcher. Instead, we use the affiliations mentioned in her publication record as a proxy. Nevertheless, even after city propagation, this list may still be noisy and, hence, does not provide the timing information easily. To illustrate this, an author may very well move to a new affiliation and publish a paper with her old affiliation because the work was done while being with the old affiliation. Therefore we considered migration sketches only. Intuitively, a sketch captures only the main stations of her researcher career. More formally, we define a migration sketch as the set of the unique affili- ations of an author ordered by the first appearance in the list of publications. For instance, in our running example, we have [2000 : Affg, 2002 : Affr] for author A1 and [2000 : Affb, 2001 : Affr, 2004 : Affg] for author A2. That 11 (a) Number of Moves (b) Ratio Figure 7: Migration statistics over time in GeoDBLP. The ration between moves and authors per year (Fig. 7b) does not grow as fast as the number of hops (Fig. 7a) or authors (Fig. 2b). Moreover, this illustrates that the job market is actually an inhomogeneous Poisson process that locally, say for periods of 10 years, can well be assumed to be homogeneous. is, Author A1 has two different affiliations, Affg appearing in 2000 the first time and the first publication with Affr in 2002. Of course, this approach has the drawback that we can not capture if a person returns to an ear- lier affiliation after several years. Finally, we dropped implausible entries from the resulting sketch database. For instance, we dropped sketches with more than ten affiliations. It is very unlikely that a single person has moved more than ten times and these sketches should rather be attributed to an insufficient entity disambiguation. Having the migration sketches at hand, we can now define a migration/move of a researcher as the event of transfer from one residential location to another by a researcher in her migration sketch. Fig. 6 shows the moves of author A2 in our running example. In total, we found 310,282 migrations in GeoDBLP. The number of moves per year is shown in Fig. 7a and it shows that the number of moves increases with the years super-linearly. However, when we normalize the numbers of moves by the number of scientists, we see roughly a linear slop, see Fig. 7b. With this information at hand, we can now start to investigate the statistical properties of researcher migration. 4 Regularities of Timing Events As mentioned above, reasons to migrate are manifold. Despite this complex web of interactions, we now show that researcher migration shows remark- ably simple but strong global regularities in the timing. 12 197019751980198519901995200020052010Year050001000015000200002500030000350004000045000HopsPerYear197019751980198519901995200020052010Year0.000.020.040.060.080.100.120.140.160.18Ratio Figure 8: Migration propensity. The individual migration propensity is best fitted by a log-normal distribution. That is, although jobs enter the market all the time, researchers are generally not "memoryless" but have to care greatly about their next move, and this timing is a multiplicative function of many independently distributed factors. 4.1 (R1) Migration Propensity is Log-Normal Given the migration sketches, we can now read off timing information. First, we estimate the propensity to transfer to a new residential location or in- stitution across scientists. To do so, let T j i be the point in time when a researcher moves from one location to the next one. Let tj i be the time between the T j i , i.e. the time between two moves, the migration propensity (see Fig. 6). It reflects the bias of researchers to stay for a specific amount of time until moving on. i . We call tj i−1 and T j Fig. 8 shows the best fitting distribution in terms of log-likelihood and KL-divergence among various distributions such as log-normal, gamma, ex- ponential, inverse-Gauss, and power-law using maximum likelihood estima- tion for the parameters. It is a log-normal distribution [1, 28]. That is, the log of the propensity is normal distribution with density ln(x) = 1 x√2πσ2 − (ln x−µ)2 e 2σ2 . (1) The parameters µ and σ2 > 0 are the mean and the standard deviation of the variable's natural logarithm. This is a plausible model due to Gibrat's "law of proportionate effects" [26]. The underlying propensity to move is a multiplicative function of many independently distributed factors, such as motivation, open positions, short-term contracts, among others. That is, such factors do not add together but are multiplied together, as a weakness in any one factor reduces the effects of all the other factors. That this leads to log-normality can be seen as follows. Recall that, by the law of large 13 10203040Years0.000.050.100.150.200.25p(x)fitdata100101Years10−610−510−410−310−210−1100p(x)datafit Figure 9: Migration propensities are remarkably similar across continents and again best fitted by log-normal. Thus, timing research careers has no cultural boundaries across continents. (Best viewed in color) numbers, the sum of independent random variables becomes a normal dis- tribution regardless of the distribution of the individuals. Since log-normal random variables are transformed to normal random variables by taking the logarithm, when random variables are multiplied, as the sample size in- creases, the distribution of the product becomes a log-normal distribution regardless of the distribution of the individuals. This might explain why the log-normal distribution is one of the most frequently observed distributions in nature and describes a large number of physical, biological and even socio- logical phenomena [20]. For example, variations in animal and plant species just as in incomes appear log-normal, i.e. normal when presented as a func- tion of logarithm of the variable. Dose-response relations just as grain sizes from grinding processes show log-normal distributions. Moreover, although the overall job market is a Poisson process, as we will show later on, it is good that the migration propensity is not exponential. It is precisely this non-Poisson that makes it possible to make predictions based on past obser- vations. Since positions are occupied in a rather regularly way, upon taking a position it is very unlikely that you will take up another position soon. In the Poisson case, which is the dividing case between clustered and regular processes, you should be indifferent to the time since the last position. Based on our data, a computer scientist stays on average 5 years at a place. Thus headhunters, for example, should approach young potentials in their fourth year. On the other hand, one should probably reconsider the common practice, e.g. in the EU and the US, of having projects lasting only 14 Figure 10: Zooming in on migration propensities: across the most productive countries they are best fitted by log-normal. Actually, the representative countries USA, China, Germany, UK, Australia, Singapore, Canada, France, Italy, and Hong Kong are shown. Except for China, all are best fitted by log- normal. China's migration propensity follows a gamma distribution. (Best viewed in color) three years to fill in the gap. More importantly, the log-normality of the propensity can be found across continents and countries of the world, see Figs. 9 and 10, where we considered only moves originating from a continent resp. country. Timing research careers has clearly no cultural boundaries! 4.2 (R2) k-th Move Propensities are Gamma Fig. 11 shows the best fitting distribution in terms of log-likelihood and KL-divergence among various distributions such as log-normal, gamma, ex- k =(cid:80)k ponential, inverse-Gauss, and power-law using maximum likelihood estima- tion for the propensity to make k > 1 migrations. More precisely, the kth move propensity for an author Ai is defined as si j. It is a gamma distribution, Γ(k)θk xk−1e− x with shape k > 0, scale θ > 0, and Γ(k) = (cid:82) ∞ θ , (2) 0 sk−1e−sds , suggesting that migration at later career stages is "memoryless". Why? Well, this follows from the theory of Poisson processes. For Poisson processes, we know that the inter-arrival times are independent and obey an exponential form, exp(t) = λe−λ·t , where λ > 0 is called the intensity rate. The important consequence of this is that the distribution of t conditioned on {t > s} is j=1 ti ga(x) = 1 15 ChinaUSAGBGermanySingaporeItalyAustraliaFranceCanadaHong Kong Figure 11: kth move propensities. The kth move propensities (left-right, top-down with k = 2, 3, 4, 5) are best fitted by gamma distributions. This suggests that migration at later career stages is "memoryless", i.e., it follows an exponential distribution. again exponential. That is, the remaining time after we have not moved to a new position at time s has the same distribution as the original time t, i.e., it is memoryless. Moreover, we know that the time until the k-th move -- the kth move propensity -- has a gamma distribution; it is the sum of the first k propensities of senior researchers. So, the propensities for the next move turn exponential for later career stages. This is plausible, since early career researchers have seldom taken many positions and, hence, we consider here rather senior researchers, which typically have permanent positions; they do not have to greatly care about their moves. As a consequence, e.g. competing universities have to top the current position of a senior researcher if they want to hire her. 4.3 Job Market is Poisson Log-Normal So far, we have shown that the propensities, let us call it δ, to move to a new residential location resp. institute follow a log-normal distribution. We have also shown that kth move propensities follow a gamma distribution, suggesting that propensities of senior researchers are exponential. The latter fact already points towards a Poisson model. More precisely, we postulate 16 10203040Years0.000.020.040.060.080.100.120.14p(x)fitdata100101Years10−810−710−610−510−410−310−210−1100p(x)datafit51015202530354045Years0.000.020.040.060.080.10p(x)fitdata100101Years10−610−510−410−310−210−1p(x)datafit510152025303540Years0.000.020.040.060.080.10p(x)fitdata100101Years10−510−410−310−210−1p(x)datafit510152025303540Years0.000.020.040.060.08p(x)fitdata101Years10−510−410−310−210−1p(x)datafit Figure 12: (Left) Brain circulation follows a gamma distribution. (Right) The inter-city migration frequency follows a power-law (after removing low- frequency connections). that the job market follows a Poisson-log-normal model [28]. That is, given a specific scientist's migration propensity δ, her probability of migrating follows a simple Poisson model: pos(k) = 1/k!· (δke−k) , for k = 1, 2, 3, 4, .... Thus the rate of the Poisson process is a function of the migration propensity. The number of migrations for all scientists having the same δ value will follow the same Poisson process. Moreover, since the sum of Poisson processes is again a Poisson process, we know that every finite sample of scientists with δs drawn from a log-normal is again following a Poisson process. Thus, assuming the job market to be a Poisson model is plausible. It actually tells us that the arrival of job openings is memoryless. Open positions should always be announced as they come. On a global scale, there is no point in waiting to announce them. There are always researchers ready to take it. And, individual researchers can always look out for new job openings. 4.4 (R3) Brain Circulation is gamma Brain circulation, or more widely known as brain drain, is the term generi- cally used to describe the mobility of high-level personnel. It is an emerging global phenomenon of significant proportion as it affects the socio-economic and socio-cultural progress of a society and a nation, and the world. Here, we defined it as the time until a researcher returns to the country of her first publication. Only 29, 398 out of 193, 986 (15%) mobile researchers, i.e., researchers that have moved at least once, and out of a total of 1, 080, 958 (3%) researchers returned to their roots (in terms of publications). As to be expected from the statistical regularity for kth move propensities, it also follows a gamma distribution, as shown in Fig. 12(left). Since a gamma dis- tribution is the sum of exponential distributions, returning is memory less. 17 510152025303540Years0.000.020.040.060.080.100.12p(x)fitdata100101Years10−610−510−410−310−210−1100p(x)datafit102Frequency10−710−610−510−410−310−210−1p(x)datafit Researchers cannot plan to return to their roots but rather have to pick up opportunities as they arrive. 5 Link Analysis of Migration Link analysis techniques provide an interesting alternative view on our mi- gration data. That is, we view migration as a graph where nodes are cities and directed edges are migration links between cities. More formally, the author-migration graph is a directed graph G = (V, E) where each vertex v ∈ V corresponds to a city in our database. There is an edge e ∈ E from vertex v1 to vertex v2 iff there is an author who has moved from an affiliation in city v1 to v2. 5.1 (R4) Inter-City Migration is Power-Law Triggered by Zipf's early work and other recent work on inter-city migra- tion [34, 6, 27], we investigated the frequency of inter-city researcher migra- tion. The frequency of a connection between two cities can be seen as knowl- edge exchange rate between the cities. It is a kind of knowledge flow because one can assume that researchers take their acquired knowledge to next af- filiation. If one looks at the author-movement-graph as a traffic network, high frequent connections corresponds to highly used streets. Fig. 12(right) shows the distribution with a fitted power-law using maximum likelihood es- timation. A likelihood comparison to other distributions such as log-normal and gamma revealed that a power-law is the best fit. Thus, there are only few pairs of cities with frequent researcher exchange and many low-frequent pairs. However, cities with a high exchange of researchers will exchange even more researchers in the future. Investments into migration pay off. 5.2 (SP 1) Migration Authorities and Hubs Next, we are interested in mining the migration authorities and hubs. To do so, we use Kleinberg's HITS-algorithm[14] on the author-migration graph. The algorithm is an iterative power method and returns two scores for every node in the graph, which are known as hubs and authorities. This termi- nology arises from the web where hubs and authorities represent websites. Hubs are pages with many outlinks and authorities are pages with many inlinks. In our context, inlinks correspond to researchers arriving in a city -- she picks up a new position -- whereas an outlink corresponds to a researcher 18 Figure 13: (left and middle) Running HITS on the directed author-migration graph reveals sending, receiving, and incubator countries. Shown are rep- resentative cities in North America (left) and Europe (middle). The size of spikes encodes the value of the "authority" (blue) and "hub" (red) scores. Incubator cities have well balanced scores. As one can see, the European cities rather send researchers. US cities at the east cost are incubators, and west cost cities receive researchers. (right) Top 25 migration cities ranked by PageRank. Compared to the productivity map in Fig. 5, one can see that productive cities are not necessarily cities with high migration flux. (Best viewed in color) leaving a city -- e.g. funding ends. Hubs can be seen as "sending" cities, i.e., they send out researcher across the world. On the other hand, author- ities can either be cities where people want to stay and tenure positions are available or where people drop out of research, i.e. heading to industry. They are "receiving" cities. Moreover, if we make the assumption that only high-quality students and scientists get new positions, one may view sending cities as institutions producing high profile scientists but also cannot hold all of them, due to restricted capacities or low attractiveness. In contrast, receiving cities might have the capacities and reputation to hold many mi- grating researchers or highly interesting industrial jobs are close by. Cities having generally high scores are incubators: they attract a lot of migration but also send them to other places. Fig. 13 shows the sending and receiving scores for cities in the repre- sentative regions of the US and Europe9. The US clearly shows an East- coast/west-coast movement. The east coast aggregates many sending cities while receiving cities dominate the west coast. This is plausible. Not only are there many highly productive universities on the west coast, see also Fig. 5, but labor market for high-tech workers in, say, the Bay Area is the strongest in a decade. Thousands of new positions are being offered by small startups and established tech giants. However, one should view many of the east-coast cities as incubators since they have high overall scores. The scores 9Rendered with WebGL Globe (see http://www.chromeexperiments.com/globe). 19 of European cities are typically much smaller, see again Fig. 13(right). Eu- rope is dominated by sending cities. Few exceptions are Berlin, Munich, Stockholm, and Zurich. The largest receiving city in the world is Singapore. This is also plausible. The city-state is known for its remarkable investment in research in recent years, as e.g. noted by a recent Nature Editorial [7]10. In contrast, the largest sending city by far is Beijing. This is also plausible. There has been upsurge in Chinese emigration to Western countries since the mid-first decade of the 21st century [15]. In 2007, China became the biggest worldwide contributor of emigrants. 5.3 (SP2) Moving Cities Following up on HITS, we also computed PageRank on the author-migration graph. Compared to HITS, PageRank [23] produces only a single score: a page is informative or important if other important pages point to it. More formally, by converting a graph to an ergodic Markov chain, the PageRank of a node v is the (limit) stationary probability that a random walker is at v. In the context of migration, this has a natural and very appealing analogy. The PageRank computes the (limit) stationary probability that a random migrator is at a city. To compute the MigrationRank of a city, the author-migration graph is transformed into the PageRank-matrix on which a power method is applied to obtain the PageRank-vector, containing a score for every node in the graph. The transformed matrix also contains the stochastic adjustment identical to the random surfer in the original work. That is, a researcher can always migrate from one affiliation to another affiliation, even if no one else did so before. Fig. 13(right) shows the top 25 cities in the world according to the MigrationRank. Compared to the productive map in Fig. 5, one can clearly see many similarities but although notable differences. The US is not only productive but thrives on migration. Vancouver, B.C., is among the top 25 when it comes to migration but not when it comes to productivity. Generally, productivity does not imply a high migration rank. Beijing, however, is top in both when it comes to productivity and migration. Singapore is higher ranked for migration than for productivity. European cities seem to also thrive on migration more than on productivity. At least there are much more cities in the top 25 than for productivity. However, compared to the US, they are less clustered together 10The recent economic pressure mounting on research communities in Singapore and around the world is not well captured in our data, which lasts to 2010 only. 20 Figure 14: Prototypical migration career of a computer scientist according to the WWW. Shown are the mean values for (kth move) propensities and brain circulation. That is, on average a scientist makes the next move after 5 years (green). Making two moves takes on average 8 years (red), and three moves 11 years (red). She moves back to her roots, if at all, after 8 years (blue). (Best viewed in color) 6 Conclusions International mobility among researchers not only benefits the individual development of scientists, but also creates opportunities for intellectually productive encounters, enriching science in its entirety, preparing it for the global scientific challenges lying ahead. Moreover, mobile scientists act as ambassadors for their home country and, after their return, also for their former host country, giving mobility a culture-political dimension. So far, however, no statistical regularities have been established for the timing of migration. In this paper, we have established the first set of statistical regularities and patterns for research migration stemming from inferring and analyzing a large-scale, geo-tagged dataset from the web representing the migration of all researchers listed in DBLP. The methods and findings highlight the value of using the World Wide Web together with data mining to fill in missing data as a world-wide lens onto research migration. Specifically, we described the creation of GeoDBLP that, in contrast to existing migration research, involved propagation of only few seed locations across bibliographic data, namely the DBLP network of authors and pa- pers. The result was a database of over 5 million unique author-paper-pairs mostly labeled with geo-tags, which was used for a detailed statistical analy- sis. The statistical regularities and patterns discovered are encouraging: we could estimate statistical regularities for migration propensities that align well but actually go beyond knowledge in the migration and scientometric literature -- typically concluded from small-scale, unregistered data only -- and establish for the first time that there are no cultural boundaries for 21 Year8YearTYear 05YearT+12nd3rd… migrationpropensity… k-thmovepropensities… braincirculationMean…Year11Year7............ the timing events underlying migration. The statistical regularity remains similar no matter what country you are looking at. Thus, moving on to a new position is a common pattern in terms of timing across different coun- tries from the US to China over Germany, and Australia and independent of geography, ideology, politics or religion. The resulting prototypical mi- gration career is sketched in Fig. 14. This is interesting, since, if nations want to get back their high-level personnel, they have to do that just before the second move, on average in the 7th year. Otherwise, it is likely that the high-level personnel does not come back anymore. And recall that only 3% of all scientists actually return. If you miss this opportunity, you will have to invest much more, since moving in later stages in a career is memoryless; there is no pressure for high-level personnel to move. On average scientists move every 5 years. This high value is due to dominance of researchers in early academic career stages. For senior scientists, that are the minority, this turns into a gamma distribution. For instance, we make two moves within 8 years on average, while making three moves takes on average 11 years. Analyzing the author-migration graph reveals for instance that China is the largest migration hub in the world, whereas Singapore is the largest migration authority. Generally, the east cost of the US receives and sends out researchers; the east cost is an incubator. In contrast, the west coast of the US is large migration authority, probably due to strong new economy and better climate. People have had this suspicion but we are showing on a very large scale that this insights go beyond folklore. In general, our findings suggest that the WWW, together with data mining to deal with missing information, may complement existing migra- tion data sources, resolve inconsistencies arising from different definitions of migration, and provide new and rich information on migration patterns of computer scientists. However, a lot remains to be done. One should monitor migration over time and validate gravity models for international migration. One should also investigate the distribution over distances trav- eled when migrating. It is certainly more complex and most likely follows a mixtures of distributions. Initial results show that there are several modes, indicating that there are cultural boundaries. Other interesting avenues for future work are geographical topic models to discover research trends across the world and to realize expert finding systems that know where the ex- perts are at any time. The most promising direction is to extend our results beyond computer science. Nevertheless, our results are an encouraging sign that harvesting and inferring data from the web at large-scale may give fresh impetus to demo- graphic research; we have only started to look through the world-wide web 22 lens onto it. Acknowledgments: This work was partly funded by the Fraunhofer ATTRACT fellowship "STREAM" and by the DFG, KE 1686/2-1. References [1] J. Aitchison and J. Brown. The Lognormal Distribution. Cambridge University Press, 1957. [2] A. Barabasi. The origin of bursts and heavy tails in human dynamics. Nature, 435:207 -- 211, 2005. [3] A. Barabasi, C. Song, and D. Wang. Handful of papers dominates citation. Nature, 491:267 -- 270, 2012. [4] Y. Bengio, O. Delalleau, and N. Le Roux. Label propagation and In O. Chapelle, B. Scholkopf, and A. Zien, edi- quadratic criterion. tors, Semi-Supervised Learning, pages 193 -- 216. MIT Press, 2006. [5] J. Bohorquez, S. Gourley, A. Dixon, M. Spagat, and N. Johnson. Com- mon ecology quantifies human insurgency. Nature, 462:911 -- 914, 2009. [6] J. Cohen, M. Roig, D. Reuman, and C. GoGwilt. International migra- tion beyond gravity: A statistical model for use in population projec- tions. PNAS, 105(40):15269 -- 15274, Oct. 2008. [7] Editorial. Singapore's salad days are over. Nature, 468(731), 2010. [8] X. Gabaix, G. Parameswaran, V. Plerou, and H. Stanley. A theory of power law distributions in financial market fluctuations. Nature, 423:267 -- 270, 2003. [9] German Council of Science and Humanities. Recommendations on ger- man science policy in the european research area. Technical Report Drs. 9866-10, Berlin 02 07 2010, 2010. [10] M. Goetz, J. Leskovec, M. McGlohon, and C. Faloutsos. Modeling blog dynamics. In Proc. of the Third International Conference on Weblogs and Social Media (ICWSM), 2009. [11] M. Gonzales, C. Hidalgo, and A. Barabasi. Understanding individual human mobility patterns. Nature, 453:779 -- 782, 2008. 23 [12] C. Hidalgo and C. Rodriguez-Sickert. The dynamics of a mobile phone network. Physica A, 287(12):3017 -- 3024, 2008. [13] P. Hui, R. Mortier, M. Piorkowski, T. Henderson, and J. Crowcoft. Planet-scale human mobility measurement. In Proc. of the 2nd ACM International Workshop on Hot Topics on Planet-Scale Measurements, 2010. [14] J. Kleinberg. Authoritative sources in a hyperlinked environment. J. ACM, 46(5):604 -- 632, Sept. 1999. [15] W. Lam. China's brain drain dilemma: Elite emigration. The Jamestown Foundation: China Brief Volume, 10(16), 2010. [16] R. Lee. The outlook for population growth. Science, 333(6042):569 -- 573, 2011. [17] J. Leskovec, L. Backstrom, and J. Kleinberg. Meme-tracking and the dynamics of the news cycle. In Proc. of the 15th ACM SIGKDD Inter- national Conference on Knowledge Discovery and Data Mining (KDD), pages 497 -- 506, 2009. [18] J. Leskovec and E. Horvitz. Planetary-scale views on a large instant- messaging network. In Proc. of the 17th International Conference on World Wide Web (WWW), pages 915 -- 924, 2008. [19] M. Ley. DBLP: some lessons learned. Proc. VLDB Endow., 2(2):1493 -- 1500, Aug. 2009. [20] E. Limpert, W. Stahel, and M. Abbt. Log-normal distributions across the sciences: Keys and clues. BioScience, 51(5):341 -- 352, 2001. [21] R. Mantegna and H. Stanley. Scaling behaviour in the dynamics of an economic index. Nature, 376:46 -- 49, 1995. [22] A. Noulas, S. Scellato, C. Mascolo, and M. Pontil. An empirical study of geographic user activity patterns in foursquare. In Proc. of the the Fifth International AAAI Conference on Weblogs and Social Media (WSCM), pages 570 -- 573, 2011. [23] L. Page, S. Brin, R. Motwani, and T. Winograd. The pagerank citation ranking: Bringing order to the web. Technical Report 1999-66, Stanford InfoLab, November 1999. 24 [24] P. Rees, J. Stillwell, P. Boden, and A. Dennett. A review of migration statistics literature. In UK Statistics Authority, Migration Statistics: the Way Ahead, Report 4, Part 2. UK Statistics Authority, London. ISBN: 978-1-85774-904-5, 2009. [25] M. Regets. Research issues in the international migration of highly skilled workers: A perspective with data from the united states. Tech- nical Report Working Paper SRS 07-203, Arlington, VA: Division of Science Resources Statistics, National Science Foundation, 2010. [26] R.Gibrat. Une loi des repartitions economiques: Leffet proportionelle. Bulletin de Statistique General, 19:469 -- 514, 1930. [27] F. Simini, M. Gonzalez, A. Maritan, and A. Barabasi. A universal model for mobility and migration patterns. Nature, 484:96 -- 100, 2012. [28] J. Stewart. The poisson-lognormal model for bibliometriy/scientometric distribitions. Information Processing and Management, 30(2):239 -- 251, 1994. [29] J. Stillwell. Inter-regional migration modelling: A review and assess- ment. In Proc. of the 45th Congress of the European Regional Science Association, 2005. [30] UN System Task Team on the Post-2015 UN Development Agenda. Migration and human mobility. Technical report, 2012. [31] D. Wang, D. Pedreschi, C. Song, F. Giannotti, and A. Barabasi. Human mobility, social ties, and link prediction. In Proceedings of the ACM SIGKDD International Conference on Knowledge Discovery and Data Mining (KDD), 2011. [32] E. Zagheni and I. Weber. You are where you e-mail: using e-mail data to estimate international migration rates. In Proc. of the ACM Conference on Web Science (WebSci), pages 348 -- 351, 2012. [33] X. Zhu and Z. Ghahramani. Learning from labeled and unlabeled data with label propagation. Technical Report CMU-CALD-02-107, Carnegie Mellon University, 2002. [34] G. Zipf. The p1p2/d hypothesis: On the inter-city movement of persons. Am. Sociol. Rev., 11:677 -- 686, 1946. 25
1512.04036
1
1512
2015-12-13T11:33:44
Tracking Idea Flows between Social Groups
[ "cs.SI", "cs.LG" ]
In many applications, ideas that are described by a set of words often flow between different groups. To facilitate users in analyzing the flow, we present a method to model the flow behaviors that aims at identifying the lead-lag relationships between word clusters of different user groups. In particular, an improved Bayesian conditional cointegration based on dynamic time warping is employed to learn links between words in different groups. A tensor-based technique is developed to cluster these linked words into different clusters (ideas) and track the flow of ideas. The main feature of the tensor representation is that we introduce two additional dimensions to represent both time and lead-lag relationships. Experiments on both synthetic and real datasets show that our method is more effective than methods based on traditional clustering techniques and achieves better accuracy. A case study was conducted to demonstrate the usefulness of our method in helping users understand the flow of ideas between different user groups on social media
cs.SI
cs
Tracking Idea Flows between Social Groups Yangxin Zhong1, Shixia Liu1∗, Xiting Wang1, Jiannan Xiao1 and Yangqiu Song2 1School of Software, Tsinghua University, Beijing, P.R. China 2Lane Department of Computer Science and Electrical Engineering, West Virginia University, United States 1{zhongyx12,wang-xt11,xjn11}@mails.tsinghua.edu.cn, [email protected], [email protected] 5 1 0 2 c e D 3 1 ] I S . s c [ 1 v 6 3 0 4 0 . 2 1 5 1 : v i X r a Abstract In many applications, ideas that are described by a set of words often flow between different groups. To facilitate users in analyzing the flow, we present a method to model the flow behaviors that aims at identifying the lead-lag relationships between word clusters of different user groups. In particular, an improved Bayesian conditional cointegration based on dy- namic time warping is employed to learn links between words in different groups. A tensor-based technique is developed to cluster these linked words into different clusters (ideas) and track the flow of ideas. The main feature of the tensor representation is that we introduce two additional dimensions to represent both time and lead-lag relationships. Experiments on both synthetic and real datasets show that our method is more effective than methods based on traditional clustering techniques and achieves better accuracy. A case study was conducted to demonstrate the usefulness of our method in helping users understand the flow of ideas between different user groups on social media. Introduction As stated in Webster's Third Edition, an idea is "a formulated thought or opinion." Hundreds of millions of users post their ideas on bursty events, hot topics, and personal lives on social media. Users from different social groups tend to interact with each other on different ideas. For example, Democrats and Republicans often interact and communicate on ideas of interest on Twitter. One idea is about the bipartisan senate immigration bill, which can be described as "immigration, bill, act, law, bipartisan." As in this example, a set of words is often used to represent an idea (Blei and Lafferty 2006). Fre- quently, idea flows between different user groups on social media to reflect social interaction and influence (Pentland 2014). These flows facilitate the transfer of information, opinions, and thoughts from group to group. For instance, idea flows between Democrats and Republicans disclose their leadership and impact on different issues ranging from presi- dential approval ratings and immigration to health care and women's equality. For the immigration idea, Democrats led the discussion of the idea since they called for this new immigration bill. However, most Republican voters were ∗S. Liu is the corresponding author. Copyright c(cid:13) 2016, Association for the Advancement of Artificial Intelligence (www.aaai.org). All rights reserved. concerned that an immigration bill might not solve border se- curity problems. As they argued and debated with each other, the immigration idea flowed between Democrats and Repub- licans. For more details about this example, please refer to our case study in the evaluation section. In many applica- tions, it is desirable to track such an idea flow and its lead- lag relationships between different groups (Liu et al. 2015; Wu et al. 2013). For this reason, the study of idea (influence) propaga- tion has received a great deal of attention (Leskovec, Back- strom, and Kleinberg 2009; Myers, Zhu, and Leskovec 2012; Shaparenko and Joachims 2007; Wu et al. 2014; Yu et al. 2015). Existing methods range from link-based and content- based to a hybrid approach (Nallapati et al. 2008). Although these methods have been successful in analyzing individual users and their connections, as well as the paths the infor- mation propagates through, less attention has been paid to studying how the ideas correlate social groups and interact with each other along time. The goal of our work is to identify an idea as a word cluster and track the lead-lag relationships between word clusters of different user groups. To achieve this goal, we first derive an augmented bipartite word graph based on the correlations and lead-lag relationships between words. Each word is rep- resented by a time series, which encodes its term frequency change over time. Since the correlation between two words can be irregular and arbitrary over time, we provide a way to automatically identify the time period in which two words are correlated. Specifically, we use dynamic time warping (DTW) to align two time series under the monotonic and slope constraint conditions of different time points (Sakoe and Chiba 1978). Then, we employ Bayesian conditional cointegration (BCC) (Bracegirdle and Barber 2012) to dis- cover the local correlation between two time series. After ap- plying BCC, we can determine whether two words have a lead or lag relationship at a particular time point. Consequently, we formulate the augmented bipartite graph as a tensor repre- sentation. In contrast to traditional time dependent data anal- ysis using tensor, which employs one additional dimension to represent time information (Sun, Tao, and Faloutsos 2006; Sun et al. 2008), we have introduced two additional dimen- sions to represent both time and lead-lag relationships. More- over, we automatically discover ideas that are represented by clusters of words by factorizing the 4-order tensor. For Figure 1: Basic idea of the idea flow model: (a) each edge is represented by a correlation vector c = [c1, ..., cT ] and a lead-lag vector ∆t = [∆t1, ..., tT ]. T is the number of time points and ck, ∆tk are the correlation value and lead-lag time between two words for the kth time point; (b) words are aggregated into ideas and edges are aggregated into flows. a certain pair of ideas, we further apply tensor factorization to cluster the time points, which can be used to segment the time series to identify the lead and lag period between ideas. To demonstrate the effectiveness of our approach, two experiments and a case study were conducted. First, we used a synthetic dataset, in which the ground truth about word clusters and their lead-lag information is known, to evaluate how the algorithm performs with different noise levels. Second, we used ten time series benchmark datasets to show that our algorithm improves the time series clustering quality by introducing local lead-lag information. Third, a case study was conducted based on a set of tweets posted by 514 members of the 113th U.S. Congress in 2013. The aim is to demonstrate how the ideas from different social groups interact with each other. Algorithm Overview Suppose each word is tracked by a time series that encodes its frequency change over time. The lead and lag relationships between ideas of different user groups can be derived using temporal correlations between words. As shown in Fig. 1, we first extract the correlation and lead-lag relationship between words. An augmented bipartite graph G = (V, E) is used to encode all the correlations and lead-lag relationships between two groups of words. Second, we discover ideas that are rep- resented by clusters of words as well as their flows between different user groups. The steps are detailed as below. • Augmented bipartite graph construction. In the first step, we calculate correlations between words to construct the augmented bipartite graph. Generally, correlations between words can be irregular and arbitrary over time for two reasons: 1) the correlation of two words may change Figure 2: An example of applying the DTW alignment. over time; 2) there are lead-lag relationships between the correlated parts (Fig. 2(a)). BCC is able to identify time periods in which two time series are correlated, but it is not able to detect the lead-lag relationships. To solve this problem, we developed an improved BCC algorithm that incorporates DTW to align two time series and detect the lead-lag relationships. With these correlations and lead- lag relationships, an augmented bipartite graph is built, in which V = VA ∪ VB represents the words that belong to user groups A or B. Each edge in E is represented by two vectors: 1) correlation vector c = [c1, ..., cT ], where T is the number of time points and ck = 1 (ck = 0) means v(i) A is correlated (not correlated) with v(j) B at the kth time point; 2) lead-lag vector ∆t = [∆t1, ..., ∆tT ], where ∆tk is the lead-lag time between words at time k. • Tracking idea flows. In this step, ideas are derived by partitioning the augmented bipartite graph into word clusters. The key challenge is to partition the augmented bipartite graph, in which each edge is represented by two vectors instead of a real number. To solve this problem, we model the augmented bipartite graph as a tensor, which uses additional dimensions to represent time and lead-lag relationships. We then apply tensor factorization tech- niques to extract a feature vector for each word and cluster the words based on these feature vectors. According to the clustering results, words are aggregated into ideas and edges are aggregated into flows (Fig. 1(b)). For each pair of ideas, we further identify their lead and lag period by clustering the time points using tensor-based techniques. Augmented Bipartite Graph Construction This section introduces our algorithm for calculating correla- tions and lead-lag relationships between words of different groups by combining BCC with DTW. Based on these corre- User Group AUser Group Bv(1)Av(2)Av(3)Av(4)Av(5)Av(6)Av(1)Bv(2)Bv(3)Bv(4)Bv(5)Bv(6)B(a) Augmented Bipartite Word Graph(b) Flow of IdeasI(1)AI(2)AI(3)AI(1)BI(2)B1[,...,]Tcc1[,...,]Ttt∆∆0100200024Time0100200024Time(a) Before applying DTW(b) After applying DTW(a) Before applying DTW0100200024Time0100200024Time(a) Before applying DTW(b) After applying DTW(b) After applying DTW Tensor Representation The key challenge of partitioning the augmented bipartite word graph is that each edge is represented by two vectors rather than a real number (Fig. 1(a)). To tackle this challenge, we model the augmented bipartite word graph as a tensor, which is able to encode time and lead-lag relationships using additional dimensions. A straightforward tensor representation is X(1) ∈ RNA×NB×T (Fig. 3(b)). Here NA and NB are the numbers of words in user groups A and B, respectively. In our imple- mentation, user groups are already identified by two profes- sors who majors in media and communications. X(1) ijk repre- sents the lead-lag relationship between the ith word in A and the jth word in B at the kth time point. We set X(1) ijk to ∆tk if the two words are correlated at the kth time point and ∞ if the two words are not correlated at that time point. However, representing uncorrelated information as ∞ may not be good enough because it can also mean one word correlated with an- other with an infinite time lead. Moreover, X(1) is very dense. As a result, computation based on X(1) is very expensive. A more reasonable solution is to extend the 3-order ten- sor to a 4-order representation: X(2) ∈ RNA×NB×T×T (Fig. 3(c)). X(2) ijkl is set to 1 if and only if the ith word in user group A is correlated to the jth word in user group B at the kth time point and l = k + ∆tk. Otherwise, X(2) ijkl is set to 0. Compared to X(1), X(2) is sparse and it clearly distinguishes between uncorrelated time points and corre- lated time points. However, X(2) fails to represent lead-lag time effectively. As shown in Fig. 3, for words v(i) A and v(j) B , the lead-lag time of the 4th time point and 5th time point are both 1. However, the feature vectors of X(2) at the 4th time point and the 5th time point (grey rows) are different ([0, 0, 0, 0, 1, 0] and [0, 0, 0, 0, 0, 1]). This leads to incorrect lead-lag results along the time dimension. To solve this issue, we redesign the 4-th dimension of X(2) to more effectively encode lead-lag time. Our design is X(3) ∈ RNA×NB×T×(2τmax+1) (Fig. 3(d)), where τmax is the maximum allowable time deviation between two aligned time points in DTW. X(3) ijkl is set to 1 if and only if the ith word in A and the jth word in B are correlated at the kth time point and l = ∆tk + τmax + 1. Otherwise, X(3) ijkl is set to 0. As shown in Fig. 3(d), the feature vectors of X(3) at 4th and 5th time points are the same ([0, 0, 1]). As a result, the 4th time point and 5th time point will be clustered into one seg- ment and we can accurately detect the lead and lag periods. Augmented Bipartite Graph Partition Based on the tensor representation, our algorithm first em- ploys tensor-based techniques to extract the feature vector for each word and then clusters the words using these features vectors. The algorithm consists of three steps. First, we employ a tensor factorization algorithm called greedy PARAFAC (Kolda, Bader, and Kenny 2005) to factor- ize the tensor. This algorithm is adopted because it is efficient and is able to deal with tensors that have more than three di- Figure 3: Three tensor representations: (a) word matrix; (b) (c) (d) three representations to encode time and lead-lag relationships. lations, we then derive an augmented bipartite word graph. Suppose we have two time series x1:T and y1:T for two words that belong to different user groups. The goal is to extract the correlation vector c = [c1, ..., cT ] and the lead-lag vector ∆t = [∆t1, ..., ∆tT ]. In particular, our algorithm consists of the following two steps. First, DTW is employed to calculate [∆t1, ..., ∆tT ]. DTW is a widely used dynamic programming algorithm that aligns two time series under the monotonic and slope constraint con- ditions of different time points (Sakoe and Chiba 1978). We choose DTW because it is both flexible and efficient (Sakoe and Chiba 1978). An example of applying DTW is shown in Fig. 2. Before applying DTW, there are misalignments between correlated parts of x1:T and y1:T (Fig. 2(a)). After applying DTW, the misaligned parts are successfully aligned together (Fig. 2(b)). ∆tk is calculated based on this alignment: if xk is aligned to yl, we set ∆tk to l − k. Second, we derive [c1, ..., cT ] by using BCC to examine the cointegration between aligned time series x(cid:48) 1:T . Cointegration describes a relationship between time series where there is a stationary linear combination. Specifically, if x(cid:48) k are cointegrated in a given time period, we have 1:T and y(cid:48) k and y(cid:48) y(cid:48) k = α + βx(cid:48) k + k, where α is a constant and β is the linear regression co- efficient. [1, 2, ..., T ] follows a mean-reverting, stationary process. Compared to typical measures such as the Pearson correlation and Spearman correlation (Bluman 2012), BCC has two advantages (Bracegirdle and Barber 2012). • BCC is able to calculate both global and local correlations while Pearson correlation and Spearman correlation can only detect global correlations. • BCC produces less spurious results compared with the classical cointegration testing approach. 1:T and y(cid:48) After applying BCC, we detect the correlation (cointegration) of x(cid:48) 1:T at different times (c(cid:48)). We then assign c(cid:48) to c according to the alignment relationships derived by DTW. Tracking Idea Flows This section introduces the tensor representation as well as tensor-based augmented bipartite graph partition and aggregation. ∞−1∞NANBvB(j)vA(i)X11∞T000000100000000000000010000001000000(a)TTmax2+1τ000100000001001000(b)(c)(d)XXT(1)(2)(3) mensions. The algorithm yields a rank-q approximation of X(3) in the form X(3) ≈ q(cid:88) λ(m)u(m) ◦ v(m) ◦ w(m) ◦ h(m), m=1 j w(m) where λ(m) ∈ R, u(m) ∈ RNA, v(m) ∈ RNB , w(m) ∈ RT , h(m) ∈ R(2τmax+1). u(m)◦ v(m)◦ w(m)◦ h(m) is the 4-way outer product so that (u(m) ◦ v(m) ◦ w(m) ◦ h(m))ijkl = u(m) i v(m) is the ith entry of vector u(m). Then we use factors {u(m)} and {v(m)} to extract feature vectors for each word in groups A and B, respectively. Take user group A as an example. The feature matrix U for this group is constructed as follows: . Here u(m) i k h(m) l U = [u(1), u(2), ..., u(q)] ∈ RNA×q. For the ith word in user group A, the feature vector is set to [Ui1, ..., Uiq]. Finally, we utilize a clustering algorithm such as K-means, on the extracted feature vectors to detect word clusters. A and I (2) Augmented Bipartite Graph Aggregation Based on the clustering results, we aggregate words into ideas and edges into flows (Fig. 1). To identify the lead and lag periods between ideas, we segment the time series for each idea pair by further applying tensor factorization. Take ideas I (1) B as an example. First, we extract a sub-tensor from X(3) that belongs to I (1) A and I (2) B . Without a loss of generality, we assume that the 1st to N1th words in A belong to I (1) A and the 1st to N2th words in B belong to I (2) B . Then the sub-tensor is denoted as 1:N1,1:N2,1:T,1:(2τmax+1) ∈ RN1×N2×T×(2τmax+1). After X(3) extracting the sub-tensor, we apply tensor factorization on it to derive a feature vector for each time point and cluster these feature vectors by using a clustering algorithm such as K-means. Based on the clustering results, we divide the time points into segments. Finally, we extract the correlation between I (1) B at the kth segment (¯ck). We average ck for all word pairs at time points that belong to this segment. If this value is greater than a given threshold, ¯ck = 1; otherwise, ¯ck = 0. If ¯ck = 1, the lead-lag time between these two ideas, ∆tk, is computed by averaging ∆tk. A and I (2) Evaluation We conducted two experiments and a case study to illustrate the effectiveness and usefulness of our idea flow tracking method. All the experiments were conducted on a worksta- tion with an Intel Xeon E52630 CPU (2.4 GHz) and 64GB of Memory. Experiment on Synthetic Data In this experiment, we used a synthetic dataset to show how our algorithm performs with different noise levels. We also compared the accuracy and efficiency of three tensor representations. Experimental Settings. In this experiment, synthetic datasets with five different noise levels were generated (noise level L ∈ {0, 0.2, ..., 0.8}). For each L, we generated 50 synthetic datasets and averaged the results of these datasets. For each dataset, we first generated ideas and the lead-lag relationships between ideas (Fig. 1(b)), which contain ¯ck and ∆tk. Then we generated the augmented bipartite word graph (Fig. 1(a)) according to noise level L. L denotes the probability that ck = 0 when ¯ck = 1. The larger the L, the more difficult it is to generate accurate idea flows by using the augmented bipartite word graph. In the synthetic datasets, the number of ideas in each user group varied from 2 to 6, the number of words in each idea varied from 10 to 30, the lead-lag time varied from -6 to 6, and the number of time points in the lead or lag periods varied from 20 to 40, all while T was set to 200. We applied our algorithm with (a) Flow F1 vs. Noise Level. (b) FlowLead F1 vs. Noise Level. (c) FlowLeadTime F1 vs. Noise Level. (d) Lead-lag Time MSE vs. Noise Level. (e) Word Clustering NMI vs. Noise Level. (f) Running Time vs. Noise Level. Figure 4: Comparison of three tensors (X(1), X(2), and X(3)) in terms of accuracy and efficiency at different noise levels. 00.20.40.60.80.50.60.70.80.91Flow_F1XXX(1)(2)(3)00.20.40.60.80.50.60.70.80.91FlowLead_F1XXX(1)(2)(3)00.20.40.60.80.50.60.70.80.91FlowLeadTime_F1XXX(1)(2)(3)00.20.40.60.8−1012MSEXXX(1)(2)(3)00.20.40.60.80.70.80.91NMIXXX(1)(2)(3)00.20.40.60.8−50050100150Time (Second)XXX(1)(2)(3) different tensors (X(1), X(2), and X(3)) to the datasets and reported the accuracy and efficiency. Criteria. We evaluated the accuracy of our algorithm based on five criteria. To evaluate the accuracy of our algorithm in detecting lead-lag relationships between ideas, we used three F1-measures: Flow F1, FlowLead F1, and FlowLeadTime F1. Flow F1 measures the accuracy of our algorithm in estimating ¯ck. FlowLead F1 is more rigorous than Flow F1. It not only measures the accuracy of ¯ck, but also measures the accuracy of our algorithm in detecting the lead or lag status (i.e., whether ∆tk > 0, ∆tk = 0, or ∆tk < 0). FlowLeadTime F1 is even more rigorous than FlowLead F1, which measures both ¯ck and ∆tk. A result with larger F1-measures is better. In addition to F1-measures, we used Mean Squared Error (MSE) to evaluate the effectiveness of our algorithm in detecting the lead-lag time ∆tk. Smaller MSE values indicate better quality. Moreover, a widely used measure for clustering quality, Normalized Mutual Information (NMI) (Strehl and Ghosh 2003), was utilized to measure the accuracy of idea identification. A larger NMI value indicates more accurate idea identification. Results. Fig. 4 compares the three tensors in terms of accu- racy and efficiency at different noise levels. The following observations can be made from the results. Accuracy. Overall, X(3) has the best performance in terms of accuracy. This demonstrates that X(3) is less sensitive to noises compared to X(1) by using two additional dimensions to encode both ck and ∆tk. Although X(2) is comparable to X(3) in terms of NMI, it is worse in terms of F1-measures and MSE. This indicates that X(2) is accurate in identifying ideas, but is not very accurate in detecting lead-lag relationships between ideas. This is due to its deficiency in clustering the time points and detecting lead and lag periods. Efficiency. As shown in Fig. 4(f), X(1) is much slower than X(2) and X(3). This is because X(2) and X(3) are much sparser than X(1). The computation time for X(2) and X(3) is comparable. Both of them are relatively efficient with a maximum computation time of 12 seconds. Because X(3) is both accurate and efficient, we used this tensor representation in the following experiments. Experiment on Real Data In this experiment, we use real-world time series benchmark datasets to demonstrate that our algorithm can improve the quality of time series clustering by incorporating local lead- lag information. Experimental Settings. The experiment was conducted on ten real-world time series datasets in the UCR archive (Chen et al. 2015), in which the class label of each time series is known. The ten time series datasets include datasets where the shapes of the time series are quite similar as well as datasets where the shapes are different. Table 1 shows the summary statistics of the UCR time series benchmark datasets used in the experiment. NMI was utilized to measure the clustering quality. We performed a grid search on τmax ({1, 2, ..., 10}) and chose the parameter with the largest NMI value (τmax = 6). To reduce any bias caused by initial cluster assignments, we ran each experiment 100 times with different random seeds and reported the mean and standard deviation. Baselines. Three baselines were used in this experiment. The first baseline (B1) was K-means (Hartigan and Wong 1979) and the second baseline (B2) was spectral clustering (Chen et al. 2011). In B1, we utilized y-values of time series to form feature vectors. In B2, we employed KDT W kernel (Marteau and Gibet 2015) to calculate similarities between time series. The third baseline (B3) was similar to our algorithm. The dif- ference is that it does not utilize DTW to calculate local lead- lag time. Instead, it calculates a global lead-lag time by mov- ing the time series forward and backward along the time axis to find the time shift that results in the highest correlation. Results. Table 2 illustrates the results of comparing our tensor-based clustering algorithm with three baselines in terms of NMI. For B3, several experiments were unable to return results within 20 days. These experiments are marked with a "\." As shown in the table, our algorithm performs bet- ter than the baselines in all datasets except for one (Fish). The major difference between our algorithm and the baselines is that the baselines did not consider local lead-lag relationships during the clustering process. In particular, B1 and B2 did not employ any lead-lag measures and B3 calculated a global lead-lag time instead of local lead-lag time. This indicates Coffee 2 56 286 L7 7 143 319 Trace 4 200 275 K N T 7 350 463 Fish OSU Leaf 6 442 427 SC 6 600 60 Strawberry 2 983 235 FA 14 2250 131 CC Wafer 3 2 4307 166 7174 152 Table 1: Summary statistics of the 10 UCR time series datasets. Here K represents the number of classes, N is the number of time series, and T denotes the number of time points. The dataset names L7, SC, FA, and CC are abbreviations for Lightning-7, Synthetic Control, Face (All), and Chlorine Concentration, respectively. Coffee 0.00±0.00 0.54±0.00 0.48±0.00 0.64±0.00 L7 0.43±0.02 0.08±0.00 0.22±0.03 0.44±0.02 Trace 0.53±0.02 0.45±0.00 0.54±0.00 0.64±0.00 Fish 0.29±0.03 0.53±0.02 0.12±0.00 0.16±0.01 OSU Leaf 0.22±0.02 0.02±0.00 0.13±0.00 0.26±0.00 SC 0.78±0.03 0.59±0.01 0.46±0.06 0.80±0.03 Strawberry 0.12±0.00 0.13±0.00 0.32±0.00 \ B1 B2 B3 Ours FA 0.37±0.02 0.24±0.00 0.39±0.09 \ CC 0.01±0.00 0.01±0.00 0.02±0.00 \ Wafer 0.00±0.00 0.04±0.00 0.19±0.00 \ Table 2: Comparison of our tensor-based clustering method with three baselines in terms of NMI on 10 datasets of the UCR time series benchmark datasets. Figure 5: Local lead-lag relationships between ideas in different user groups. immigration, bill, act, law, bipartisan military, join, service, honor, nation 1 2 3 women, american, succeed, job, equality 1 2 3 tax, economy, reform, family, icymi job, plan, student, school, program obamacare, senate, gop, vote, congress Table 3: Top three ideas led by Democrats. Table 4: Top three ideas led by Republicans. that the clustering quality can be improved by using local lead-lag relationships. Next, we examined why our algo- rithm is worse than B1 and B2 in the Fish dataset. We found time series with similar shapes but different amplitudes are labelled to be different in this dataset. Since B1 and B2 use absolute y-values of the time series, they are more accurate in distinguishing such time series. Frequently, the time series of words that have similar shapes but different amplitudes are regarded as correlated. As a result, our algorithm is more appropriate to process textual data. Case Study on Twitter Data To demonstrate the usefulness of our algorithm in detecting idea flows, we conducted a case study with a professor who majors in media and communications. The dataset contains 156,501 tweets posted by 514 members of the 113th U.S. Congress from Apr. 9 to Oct. 13, 2013. The professor and another professor who also majors in media and communica- tions manually divided these members into two groups: 243 Democrats and 271 Republicans. We segmented the data into 94 time points (every 2 days). Stopwords and rare words that occur less than 5 times each day by average were removed to reduce noise. We extracted 15 ideas for each group. First, we checked the global lead-lag relationships between all ideas. We found there were 119 lead-lag relationships on pairs of ideas. Among these pairs, 62 (52%) were led by Democrats and 57 (48%) were led by Republicans. This result demonstrated that Democrats marginally outperformed Republicans in taking the lead at that time. The professor con- firmed our findings. He said President Obama (Democratic) started to realize the political importance of social media after he was re-elected as President in 2012. After that, Democrats put more effort into social media. Because the president was a Democrat and the Democratic Party had a Senate majority, Democrats had an advantage over Republicans in leading public opinion. We next examined the ideas that were led by Democrats and Republicans, respectively. We ranked the ideas by the number of time points at which they led other ideas. The top three ideas for Democrats are shown in Table 3. The professor immediately identified that they were the bipartisan senate immigration bill, honoring military service members, and women's equality. By checking related tweets, the professor found Democrats took the lead on these ideas because they were more supportive of them. Take the "bipartisan senate immigration bill" idea as an example. Because Democrats supported this bill, they kept on posting the latest information about this bill and hosted new activities ("House leaders should allow debate & vote on Bipartisan Senate Immigration Bill. It's not perfect but we need reform. http://t.co/btKDxblbQf"). Republicans lagged because they mainly responded by disapproving of Democrats' ideas. One major concern was that the immigration bill might not solve border security problems ("The immigration bill offers false promises about border security and enforcement measures."). The professor commented that this kind of interaction is common between Democrats and Republicans. Next, we checked the ideas led by Republicans. As shown in Table 4, the top three were tax reform, Republican's plan to create jobs, and health care vote in Congress (IR). While Republicans were supportive of tax reform and plans to create jobs, they did not support Obama's health care plan (Oba- macare). To understand why IR was led by Republicans, we examined the correlated ideas from Democrats. Among them, the idea with the largest lag-time (ID) was exemplified by words "gov," "obamacare," "debt," "capitol," and "pay," which all are related to Obamacare. To know why IR led ID, we further checked the local lead-lag relationships between the two ideas. As shown in Fig. 5, each idea is represented by a colored stripe while the x-axis represents time. The width of a stripe changes over time, encoding the temporal "hot- ness" of this idea. The "hotness" is measured by the number of words that talks about this idea at each time. The local lead-lag relationships are visualized by the links that connect correlated time points. Fig. 5 shows that the main lead period for idea IR is from Jul. 31 to Aug. 20 (Fig. 5A). By checking the two peaks (Fig. 5B and Fig. 5C) on the stripe during this time period, we found Republicans led this idea because they were very active in opposing the health care plan. On Aug. 2 (Fig. 5B), they voted to repeal Obamacare for the 40th time. Around Aug. 13 (Fig. 5C), they posted many tweets criti- cizing the fact that a key consumer protection in the health care plan was delayed ("Yet another delay for Obamacare via @CBSNews - Key consumer protection in Obamacare delayed http://t.co/0brYxzjUj7"). ABCJul. 31Aug. 20obamacare, senate,gop, vote, congress gov, obamacare,debt, capitol, pay(cid:9)(cid:1)(cid:1)(cid:1)(cid:1)(cid:1)(cid:1)(cid:1)(cid:1)(cid:1)(cid:1)(cid:1)(cid:1)(cid:1)(cid:10)(cid:9)(cid:1)(cid:1)(cid:1)(cid:1)(cid:1)(cid:1)(cid:1)(cid:1)(cid:1)(cid:1)(cid:1)(cid:1)(cid:1)(cid:1)(cid:1)(cid:10)RepublicanDemocratRIDI Related Work with each other along time. Our work is relevant to influence analysis between docu- ments. Previous research on influence analysis can be cat- egorized into three groups: content-based, link-based, and hybrid methods. Content-based methods use the content of documents and their temporal changes to analyze influence (Cui et al. 2011b; Liu et al. 2012; Shaparenko and Joachims 2007; Zhang et al. 2010). Shaparenko and Joachims assumed the language model of a new document is a mixture of the language model of all previously published documents (Shaparenko and Joachims 2007). They adopted a likelihood ratio test to detect the influence between documents. However, their method cannot model influence at the word level. To learn the influence at the word/phrase level, MemeTracker (Leskovec, Backstrom, and Kleinberg 2009) employed a graph-based method to cluster variants of phrases and derive correspond- ing threads in the news cycle. To link two given doc- uments with a coherent chronological chain, Shahaf and Guestrin (Shahaf and Guestrin 2010) employed a bipartite graph between words and documents and utilized the graph to model the influence between two documents. Compared with this work, our method builds an augmented bipartite graph between words used by two user groups by employing the improved BCC technique. The bipartite link is represented by a set of correlation values and lead-lag times between two words at different times instead of a single weight. As a result, we can model the influence between groups from a global overview to local temporal details. Link-based methods use links (e.g., citations or follower- followee relationships) in a network to analyze influence. PageRank (Brin and Page 1998) and its variations (Haveli- wala 2002; Ma, Guan, and Zhao 2008) are typical exam- ples of such methods. Researchers also studied the problem of influence maximization in a network (Feng et al. 2014; Kempe, Kleinberg, and Tardos 2003; Ohsaka et al. 2014). However, link-based methods need to utilize explicit links in the data to model influence. Such kind of links may not be available in many real-world datasets such as news articles. To solve this issue, researchers have developed hybrid methods that use both links and content to analyze in- fluence (Cui et al. 2011a; El-Arini and Guestrin 2011; Gomez Rodriguez, Leskovec, and Krause 2010). For exam- ple, given the topics discussed in a network, Tang et al. (Tang et al. 2009) constructed a factor graph to compute the topic level influence in a large network. To model influence as well as topics in a corpus, researchers have proposed several topic models that incorporate links between documents (Dietz, Bickel, and Scheffer 2007; Erosheva, Fienberg, and Lafferty 2004; Gerrish and Blei 2010; Guo et al. 2010; Guo et al. 2014; Liu et al. 2010; Nallapati et al. 2008; Nallapati and Cohen 2008). Influence can also come from outside the network. Myers et al. (Myers, Zhu, and Leskovec 2012) developed an information diffusion model to integrate both the internal influence and the external influence in a network. The major issue of hybrid methods is that they model influence at the document, user, or topic level. In contrast, our method aims at detecting ideas at the word level and studying how the ideas correlate social groups and interact Conclusions and Future Work In this paper, we have aimed to help users understand how ideas propagate between different groups. To this end, we first derive an augmented bipartite word graph based on the correlations between words. The major feature of the aug- mented bipartite graph is that its edge is represented by two vectors: a correlation vector and a lead-lag vector. The two vectors, along with the augmented bipartite graph, are for- mulated as a tensor representation. Next, by factorizing the tensor, we automatically discover ideas that are represented by clusters of words. For a certain pair of ideas, we further ap- ply tensor factorization to cluster the time points, which can be used to segment the time series to identify the lead and lag period between ideas. Finally, our evaluation demonstrates that the developed approach is generally more effective than the baseline methods. One interesting direction for future work is exploring a wider range of text data representations for better tracking idea flows on social media. Text data is typically treated as bag-of-words. In this paper, we follow this paradigm since this representation is simple and easy to be understood. There are some advanced techniques that can convert the unstructured text to a network with typed entity and relation information (Wang et al. 2015a; Wang et al. 2015b; Wang et al. 2016), which can be less ambiguous than only using bag-of-words. Integrating these techniques with our model is a very interesting topic for further study in the future. In addition, we would like to study the lead-lag relationships within each user group and combine them with the lead- lag relationships between different user groups for better modeling idea flows on social media. Acknowledgements We would like to thank Mengchen Liu for valuable contri- butions on related work and the model formulation. This research was supported by the National Key Technologies R&D Program of China (2015BAF23B03) and a Microsoft Research Fund (No. FY15-RES-OPP-112). References [Blei and Lafferty 2006] Blei, D. M., and Lafferty, J. D. 2006. Dy- namic topic models. In ICML, 113 -- 120. [Bluman 2012] Bluman, A. G. 2012. Elementary statistics: A step by step approach. McGraw-Hill. [Bracegirdle and Barber 2012] Bracegirdle, C., and Barber, D. 2012. Bayesian conditional cointegration. In ICML, 1095 -- 1102. [Brin and Page 1998] Brin, S., and Page, L. 1998. The anatomy of a large-scale hypertextual web search engine. Computer networks and ISDN systems 30(1):107 -- 117. [Chen et al. 2011] Chen, W.-Y.; Song, Y.; Bai, H.; Lin, C.-J.; and Chang, E. Y. 2011. Parallel spectral clustering in distributed systems. PAMI 33(3):568 -- 586. [Chen et al. 2015] Chen, Y.; Keogh, E.; Hu, B.; Begum, N.; Bagnall, A.; Mueen, A.; and Batista, G. 2015. The ucr time series classifica- tion archive. www.cs.ucr.edu/eamonn/time_series_ data/. [Cui et al. 2011a] Cui, P.; Wang, F.; Yang, S.; and Sun, L. 2011a. Item-level social influence prediction with probabilistic hybrid fac- tor matrix factorization. In AAAI. [Cui et al. 2011b] Cui, W.; Liu, S.; Tan, L.; Shi, C.; Song, Y.; Gao, Z.; Qu, H.; and Tong, X. 2011b. Textflow: Towards better under- standing of evolving topics in text. TVCG 17(12):2412 -- 2421. [Dietz, Bickel, and Scheffer 2007] Dietz, L.; Bickel, S.; and Schef- fer, T. 2007. Unsupervised prediction of citation influences. In ICML, 233 -- 240. [El-Arini and Guestrin 2011] El-Arini, K., and Guestrin, C. 2011. Beyond keyword search: Discovering relevant scientific literature. In KDD, 439 -- 447. [Erosheva, Fienberg, and Lafferty 2004] Erosheva, E.; Fienberg, S.; and Lafferty, J. 2004. Mixed-membership models of scientific publications. PNAS 101(suppl 1):5220 -- 5227. [Feng et al. 2014] Feng, S.; Chen, X.; Cong, G.; Zeng, Y.; Chee, Y. M.; and Xiang, Y. 2014. Influence maximization with novelty decay in social networks. In AAAI. [Gerrish and Blei 2010] Gerrish, S., and Blei, D. M. 2010. A language-based approach to measuring scholarly impact. In ICML, 375 -- 382. [Gomez Rodriguez, Leskovec, and Krause 2010] Gomez Ro- driguez, M.; Leskovec, J.; and Krause, A. 2010. Inferring networks of diffusion and influence. In KDD, 1019 -- 1028. [Guo et al. 2010] Guo, Z.; Zhu, S.; Zhang, Z.; Chi, Y.; and Gong, Y. 2010. A topic model for linked documents and update rules for its estimation. In AAAI. [Guo et al. 2014] Guo, Z.; Zhang, Z. M.; Zhu, S.; Chi, Y.; and Gong, Y. 2014. A two-level topic model towards knowledge discovery from citation networks. TKDE 26(4):780 -- 794. [Hartigan and Wong 1979] Hartigan, J. A., and Wong, M. A. 1979. Algorithm as 136: A k-means clustering algorithm. Applied statis- tics 100 -- 108. [Haveliwala 2002] Haveliwala, T. H. 2002. Topic-sensitive pager- ank. In WWW, 517 -- 526. [Kempe, Kleinberg, and Tardos 2003] Kempe, D.; Kleinberg, J.; and Tardos, E. 2003. Maximizing the spread of influence through a social network. In KDD, 137 -- 146. [Kolda, Bader, and Kenny 2005] Kolda, T.; Bader, B.; and Kenny, J. 2005. Higher-order web link analysis using multilinear algebra. In ICDM, 242 -- 249. [Leskovec, Backstrom, and Kleinberg 2009] Leskovec, J.; Back- strom, L.; and Kleinberg, J. 2009. Meme-tracking and the dynamics of the news cycle. In KDD, 497 -- 506. [Liu et al. 2010] Liu, L.; Tang, J.; Han, J.; Jiang, M.; and Yang, S. 2010. Mining topic-level influence in heterogeneous networks. In CIKM, 199 -- 208. [Liu et al. 2012] Liu, S.; Zhou, M. X.; Pan, S.; Song, Y.; Qian, W.; Cai, W.; and Lian, X. 2012. Tiara: Interactive, topic-based visual text summarization and analysis. ACM TIST 3(2). [Liu et al. 2015] Liu, S.; Chen, Y.; Wei, H.; Yang, J.; Zhou, K.; and Drucker, S. M. 2015. Exploring topical lead-lag across corpora. IEEE TKDE 27(1):115 -- 129. [Ma, Guan, and Zhao 2008] Ma, N.; Guan, J.; and Zhao, Y. 2008. Bringing pagerank to the citation analysis. Information Processing & Management 44(2):800 -- 810. [Marteau and Gibet 2015] Marteau, P.-F., and Gibet, S. 2015. On recursive edit distance kernels with application to time series classi- fication. TNNLS 26(6):1121 -- 1133. [Myers, Zhu, and Leskovec 2012] Myers, S. A.; Zhu, C.; and Leskovec, J. 2012. Information diffusion and external influence in networks. In KDD, 33 -- 41. [Nallapati and Cohen 2008] Nallapati, R. M., and Cohen, W. W. 2008. Link-plsa-lda: A new unsupervised model for topics and influence of blogs. In ICWSM. [Nallapati et al. 2008] Nallapati, R. M.; Ahmed, A.; Xing, E. P.; and Cohen, W. W. 2008. Joint latent topic models for text and citations. In KDD, 542 -- 550. [Ohsaka et al. 2014] Ohsaka, N.; Akiba, T.; Yoshida, Y.; and Kawarabayashi, K.-i. 2014. Fast and accurate influence maxi- mization on large networks with pruned monte-carlo simulations. In AAAI. [Pentland 2014] Pentland, A. P. 2014. Social Physics: How Good Ideas Spread-The Lessons from a New Science. Penguin Press. [Sakoe and Chiba 1978] Sakoe, H., and Chiba, S. 1978. Dynamic programming algorithm optimization for spoken word recognition. Acoustics, Speech and Signal Processing 26:43 -- 49. [Shahaf and Guestrin 2010] Shahaf, D., and Guestrin, C. 2010. Con- necting the dots between news articles. In KDD, 623 -- 632. [Shaparenko and Joachims 2007] Shaparenko, B., and Joachims, T. 2007. Information genealogy: Uncovering the flow of ideas in non-hyperlinked document databases. In KDD, 619 -- 628. [Strehl and Ghosh 2003] Strehl, A., and Ghosh, J. 2003. Cluster ensembles - a knowledge reuse framework for combining multiple partitions. JMLR 3:583 -- 617. [Sun et al. 2008] Sun, J.; Tao, D.; Papadimitriou, S.; Yu, P. S.; and Faloutsos, C. 2008. Incremental tensor analysis: Theory and applications. TKDD 2(3). [Sun, Tao, and Faloutsos 2006] Sun, J.; Tao, D.; and Faloutsos, C. 2006. Beyond streams and graphs: dynamic tensor analysis. In KDD, 374 -- 383. [Tang et al. 2009] Tang, J.; Sun, J.; Wang, C.; and Yang, Z. 2009. Social influence analysis in large-scale networks. In KDD, 807 -- 816. [Wang et al. 2015a] Wang, C.; Song, Y.; El-Kishky, A.; Roth, D.; Zhang, M.; and Han, J. 2015a. Incorporating world knowledge to document clustering via heterogeneous information networks. In KDD, 1215 -- 1224. [Wang et al. 2015b] Wang, C.; Song, Y.; Li, H.; Zhang, M.; and Han, J. 2015b. Knowsim: A document similarity measure on structured heterogeneous information networks. In ICDM. [Wang et al. 2016] Wang, C.; Song, Y.; Li, H.; Zhang, M.; and Han, J. 2016. Text classification with heterogeneous information network kernels. In AAAI. [Wu et al. 2013] Wu, F.; Song, Y.; Liu, S.; Huang, Y.; and Liu, Z. 2013. Lead-lag analysis via sparse co-projection in correlated text streams. In CIKM, 2069 -- 2078. [Wu et al. 2014] Wu, Y.; Liu, S.; Yan, K.; Liu, M.; and Wu, F. 2014. Opinionflow: Visual analysis of opinion diffusion on social media. IEEE TVCG 20(12):1763 -- 1772. [Yu et al. 2015] Yu, L.; Cui, P.; Wang, F.; Song, C.; and Yang, S. 2015. From micro to macro: Uncovering and predicting informa- tion cascading process with behavioral dynamics. arXiv preprint arXiv:1505.07193. [Zhang et al. 2010] Zhang, J.; Song, Y.; Zhang, C.; and Liu, S. 2010. Evolutionary hierarchical dirichlet processes for multiple correlated time-varying corpora. In KDD, 1079 -- 1088.
1308.2938
1
1308
2013-08-13T18:48:49
ERP projects Internal Stakeholder network and how it influences the projects outcome
[ "cs.SI", "cs.CY" ]
So far little effort has been put into researching the importance of internal ERP project stakeholders mutual interactions,realizing the projects complexity,influence on the whole organization, and high risk for a useful final outcome. This research analyzes the stakeholders interactions and positions in the project network, their criticality, potential bottlenecks and conflicts. The main methods used are Social Network Analysis, and the elicitation of drivers for the individual players. Information was collected from several stakeholders from three large ERP projects all in global companies headquartered in Finland, together with representatives from two different ERP vendors, and with two experienced ERP consultants. The analysis gives quantitative as well as qualitative characterization of stakeholder criticality (mostly the Project Manager(s), the Business Owner(s) and the Process Owner(s)), degree of centrality, closeness, mediating or bottleneck roles, relational ties and conflicts (individual, besides those between business and project organizations), and clique formations. A generic internal stakeholder network model is established as well as the criticality of the project phases. The results are summarized in the form of a list of recommendations for future ERP projects to address the internal stakeholder impacts .Project management should utilize the latest technology to provide tools to increase the interaction between the stakeholders and to monitor the strength of these relations. Social network analysis tools could be used in the projects to visualize the stakeholder relations in order to better understand the possible risks related to the relations (or lack of them).
cs.SI
cs
ERP project’s Internal Stakeholder network and how it influences the project’s outcome Kristian J(cid:129)(cid:129)skel(cid:129)inen, Accenture Finland; and L-F Pau, Prof. Mobile business, Copenhagen Business School and Rotterdam school of management [email protected] ABSTRACT So far little effort has been put into researching the importance of internal ERP project stakeholders’ mutual interactions, realizing the project’s complexity, influence on the whole organization, and high risk for a useful final outcome. This research analyzes the stakeholders’ interactions and positions in the project network, their criticality, potential bottlenecks and conflicts. The main methods used are Social Network Analysis, and the elicitation of drivers for the individual players. Information was collected from several stakeholders from three large ERP projects all in global companies headquartered in Finland, together with representatives from two different ERP vendors, and with two experienced ERP consultants. The analysis gives quantitative as well as qualitative characterization of stakeholder criticality the Project Manager(s), (mostly the Business Owner(s) and the Process Owner(s)) , degree of centrality, closeness , mediating or bottleneck roles, relational ties and conflicts (individual, besides those between business and project organizations) , and clique formations. A generic internal stakeholder network model is established as well as the criticality of the project phases. The results are summarized in the form of a list of recommendations for future ERP projects to address the internal stakeholder impacts .Project management should utilize the latest technology to provide tools to increase the interaction between the stakeholders and to monitor the strength of these relations. Social network analysis tools could be used in the projects to visualize the stakeholder relations in order to better understand the possible risks related to the relations (or lack of them). INTRODUCTION organizations facing are Several demanding company-wide Enterprise resource planning (ERP) projects in the coming years. ERP projects are expensive, complex and influence the whole organization. The challenge is to make them successful. There are many examples of failed attempts which have cost millions of dollars without bringing the benefits they were supposed to. There has been a lot of research on ERP project’s critical success factors and the results have emphasized the importance of top management support, ERP systems architecture effective flexibility, communication and change management, organization minimal participation, customization just to name a few. Nah et al. (2001) and others have looked at several ERP projects and concluded that there are 11 factors that are critical to ERP project implementation; most of those listed are technical or relate to the overall information management strategy of the company, and policies procedures, standards . So far in little effort has been put researching the importance of the project stakeholders individually or as a network (Rowley, 1997) (ITToolbox, 2006). In an ERP project, the social relations between the stakeholders become essential: stakeholders form a network consisting of relations; influencing each other, the decisions made during the project and the final outcome. Each stakeholder has his or her own drivers, based on which they act during the project. influence the Potential drivers, which decision making individual an of stakeholder, could be fear of loosing power in the the organization but also be opposite, will to increase own power, which could be achieved for instance by performing well in the project and gaining recognition from other stakeholders. Other potential drivers could be the fear of being held responsible of a decision, influencing the willingness to make decisions, and on the other hand willingness to influence areas where the stakeholder doesn’t have the end responsibility. In sum, each individual has his own drivers and objectives trying to influence the other stakeholders so that those objectives would be realized. Although having many commonalities with other IS projects, ERP projects differ in many ways from other projects by being so comprehensive from the organizational point of view. An ERP project normally involves company-wide business process redesign and covers most of the company’s processes influencing almost everyone in the organization. So far much of the research on stakeholder issues in ERP projects has been drifting too far from current issues. By current issues are meant the problems, which the IS professionals face in their daily work. This research is aiming at providing concrete conclusions and recommendations for the ERP project professionals in order to avoid, or at least to mitigate, the project’s risks related to the stakeholders and their relations. The paper addresses as main research question:  What is the ERP project’s Internal Stakeholder network and how does it influence the project’s outcome? Sub questions, which further define the main question, are: the key stakeholders  Who are inside once an ERP project launched?  Who are the most critical stakeholders inside an ERP project?  Who are the potential intra- personal conflicts and bottlenecks that can affect the project? to  What are risks related the internal their stakeholders and position in the network?  What are the drivers behind internal stakeholders’ actions?  What relations type of between the stakeholders? This experimental research focuses on three large company-wide ERP projects at companies headquartered in Finland, which have all already implemented ERP systems ranging from thousand to several thousands of ERP users. All of the projects cover the main business processes, such as finance and controlling, demand planning and manufacturing, sales and logistics etc. exists The originality of this research is based on the fact that it is using a theoretical approach which has not been used widely in information systems research, since it belongs traditionally to sociological sciences, namely Social network analysis (SNA). However, in sociology as well as in communications traffic analysis this theory is widely used in order to research human relations. An ERP project if any is based on human relations so therefore the Social Network Analysis theory is seen as relevant. SNA has the ability to describe the real stakeholder relations inside a project instead of the traditional approach which is based mainly on the official organization structures on one hand and the contractual aspects on the other hand. When only looking at the official organization execution project and structures many relevant details of the stakeholders’ interaction with each other are ignored. Supported by the SNA theory, incentive analysis, and metrics collected during the analysis of three large ERP projects in Finland, this research explains the ERP project’s key stakeholders, their motives, relations stakeholders; the between identifies the most critical roles, possible conflicts and bottlenecks in the project organization. This information helps to better understand how the project’s internal stakeholder relations influence an ERP project and how the risks (time, costs, quality of the ERP implementation, error rates, etc ...) related to the stakeholder relations could be minimized. The three companies which have been investigated differ heavily from each other. The first one is a well known large services company acting only in the Finnish markets, the second is a middle sized traditional manufacturing company with international focus, the third one a large international hi-tech company. The differences between the companies have detailed allowed gathering specific information from three different organizational environments. The research population is the internal ERP project stakeholders in the three different projects (one project per company), completed with stakeholders external to the three deployment companies for validation of the results, including representatives from two ERP- software providers and from a systems integration consultancy company. After a survey and discussion of the relevance of this research, the paper presents the methodology used with the cases and the information collection. The analysis and quantitative provides qualitative results, leading to a list of recommendations for future ERP projects, before some conclusions. SURVEY AND RELEVANCE OF THE RESEARCH Enterprise Resource Planning (ERP) has been a hot topic since the early 90’s. Since many implementations, costing millions of dollars have failed to bring the intended benefits there is a need to conduct research on which the influence factors implementation process. ERP projects are a complex mixture of technology, business, organization and politics. Therefore there are many factors that influence their success or failure. In this Section the relevance of the research problem is explained the demonstrating by economical scale and importance of the ERP projects and how big implications a project failure might have for a company. An average ERP project lasts normally between one and three years (Komiega, 2001; Darwin’s Executive Guide, 2004). It is difficult to say accurately how much ERP projects cost in average, due to the fact that the projects differ a lot from each other for instance scope wise. Nevertheless, there has been research indicating the total costs of ownership for an ERP project. Meta Group made a research surveying 63 companies from small to large in different industries and their conclusion was that an average project’s total costs, from the beginning of the project till two years after the project completion, was US$ 15 Million, the average cost per user being as high as $53 000 (Darwin’s Executive Guide, 2004). The rate of success of the projects has been researched by many. According to Rao (2000) as many as 96,4 percent of ERP implementations fail. Supporting the high failure rate, but with a different rate, Al- Mashari (2000) concluded that 70 percent of ERP implementations fail to achieve the estimated benefits. According to Koch (2002) 40 percent of ERP project managers failed to achieve their original business case even after the ERP system being live for a year or more. Over 20 percent stop their projects before completion. Even in the projects who claim being successful, costs were on average 25 % over budget and annual support costs went up by an average of 20 % over the legacy systems they replaced. A survey by Robbins-Gioia consultancy concluded that 51 % of companies were not satisfied with the ERP project results. Although many reports indicate that ERP projects fail easily not everyone agrees with this view amongst vendors, consultants but also users. AMR Research Inc. analyst Jim Shepherd claims that the end result is positive in most cases in the long run. According to him in almost every case, when you encounter a story about a failed ERP project, if you went back a year later, you would find that they are happily using the system (Robb, 2006). Whether the high failure rate is accurate or not there are plenty of examples of major problems when implementing a new ERP system even when learning is present. Probably one known failure is the US fourth of distributor largest pharmaceuticals FoxMeyer Drugs’ SAP R/3 project followed by a bankruptcy in 1996 due issues with e.g. to major inventory management (Davenport, 1998). Another example of an unsuccessful ERP project is from the Norwegian Defense Forces. Their spokesman Sigurd Frisvold said in January 2005 that the ERP project exceeded its budget only in 2004 alone by approximately €100 Million. The Defense Forces admitted that the reason for the problems was neither the platform nor the software but the failure to adjust the organization to the new system (Savolainen, 2005). An example from Finland is KCI Konecranes who had a € 50 Million dispute with Baan after a failed Omniman ERP-system implementation in 2000. After a long legal fight in several countries the companies were able to reach an agreement. The result of the agreement was kept secret (Torikka, 2003). ERP project issues might have dramatic consequences for a company. Hershey Foods, one of the largest candy companies in US found out about this in the worst possible way. Hershey’s new SAP system, Siebel CRM system and Manugistics supply chain software project, costing $112 Million, failed causing problems for the whole order and distribution system and serious problems for the business. The company around situation a faced Halloween where it could loose orders totaling $100 Million. When Wall Street heard of the problems Hershey’s stock instantly dove with 8% in one day. Eventually it was found out that Hershey’s problems were not unique, but the same occurred in most projects. Hershey just happened to have a bad timing for the problems just before high sales Halloween. The lesson Hershey management learned was that the system implementation is “easy”. The difficult part is to get the personnel to change the way they are working. But eventually they will adapt. Other lesson was that ERP software is not just software. ERP changes the way the company conducts the business. (Koch, 2002) What must be realized when reading these “horror stories” is that some business areas might in difficulties have more implementing ERP systems than others due to more complex or unexpected turns in the business environment. There is a difference between implementing an ERP system traditional manufacturing in a company with standard processes, which are “easier to control” than in a company selling services to consumers in a fast changing business environment. That is why there are less stories about major challenges for instance from the oil or metal in health care, than industries telecommunications services or consumer goods industries. The experiences of failing can also derive from wrong expectations. Companies do not necessarily understand what to expect from the new system. Quite surprisingly a majority of the companies do not put much effort in calculating the breakdown of benefits the new system is supposed to bring. Bradford and Richtermeyer (2002) found out in their research that 57% of companies who invest in an ERP-system do not make detailed calculations of the benefits, in other words the business case is not made thoroughly. What is common to the failure stories is that all of them emphasize the importance of the organizational aspect. None of the projects blame only the ERP software, hardware is vendor who the or implementing the system. In most cases not enough attention has been paid to the organizational aspect, how to make sure that the organization is ready for the change. Even though the most critical success factors have been listed by many researchers, many have pointed out that more studies should be made about how internal power structures and networks influence Information System projects (Butcher and Clark 1999; Dhillon, 2003; Silver et al., 1995). “What are the drivers behind stakeholders’ decisions and actions?” and “How do the stakeholders influence each other?” are very relevant questions for all ERP projects. Looking at a concrete example of stakeholders’ importance, Nestl(cid:133) USA faced severe problems with their ERP implementation in 1999 because the project management forgot to involve the stakeholders in the project. None of the groups that were going to be directly affected by the new processes and systems were represented in the key stakeholder team. This lead to a situation where the key stakeholders, from executives to factory floor workers, didn’t know how to use the new ERP system and they didn’t understand the new business processes either. The conflict escalated to what was the only way to solve it, which was to invite all the stakeholders together, discuss the problems thoroughly, and redesign the ERP solution (Worthen, 2002). "Organization charts prescribe that work and information flow in a hierarchy, but network mapping reveals actually this flow through a vast web of informal channels." (Krebs, 2006). Rice and Aydin (1991) have looked at how much employees influence each others opinions about a new IS system. They concluded that attitudes towards an information system are socially influenced by the people to whom the employee has close relations. Even though these studies do provide useful information for the project management the subject should be further studied and that is what this research is aiming at doing. Even though most research, which measured the influence of a new Information System on an organization, have concluded that the stakeholders are in key position for the success, no one has tried in the context of an ERP implementations to analyze the stakeholder relations and their importance in more detail during the project execution; this would involve mapping the entire stakeholder network, the actors, the influence of relations on the actors, strength of these relations etc. This paper is using Social Network Analysis (SNA) theory to determine all these factors and to create an overall generic model, which can benefit the planning of future ERP projects. Most of the early research in the area has concentrated on organization’s resistance to change. Some have looked at the subject from a power balance perspective, looking at how a new Information System stirs up the current power balance in the organization. New information system’s influence on the organization, its power structures and resistance to change in IS projects, have been researched amongst others by Keen (1981), Markus (1983), Markus and Pfeffer (1983) and Newman and Rosenberg (1985). Von Hellens, Nielsen and Beekhuyzen (2005) conducted a qualitative case study on power and politics in an ERP implementation. Their conclusion was that the new system influences the internal power balance between the stakeholders, which can have significant influences on the organization. Burkhardt and Brass (1990) and Rice and Aydin (1991) have used SNA in researching how new IS systems influence the organization and the internal power structure. According to Burkhardt and Brass (1990) a new IS system increases uncertainty. At the same time those who are able to mitigate the uncertainty gain more power. The increased uncertainty also increases the need to communicate about that uncertainty, which changes the social communication network. What this has to do with an ERP project is that ERP normally comes together with a business process redesign, which stirs the organization structure, in other words the internal power structure. Because of the business process redesign the power of certain employees or departments might diminish. Keen (1981), Markus (1983) demonstrated how an IS project influences the power structures by redistributing data (information). According to Hellens et al. (2005) a new IS can change also other aspects of an organization, such as communication paths, and influence, control. Similar effects exist inside an ERP project organization within the company, as obviously successful implementations raise the credibility and image of the project leaders inside the company or for new roles. The research on ERP project’s influence on power and politics does have much in common with the subject of this paper. However, the main difference between the previous research and this paper is the perspective. The previous research has concentrated on finding out how the company’s power structure has changed because of the ERP project and what causes the resistance to change. This paper is concentrating on analyzing how the ERP implementation project’s stakeholders and their mutual relations influence the ERP project internally once launched and its outcome. In other words this research is and influence. The research aims at validating the model, the key internal stakeholders, their relations and the direction and the strength of the relation. The motivators or drivers (circle around the stakeholders in the graph in Figure 1) demonstrate that each stakeholder’s behavior is influenced by various factors, both personal and organizational. The drivers have three dimensions. The positive drivers make the stakeholders to support the project and the negative drivers create resistance. The third dimension is time. Timing of the project can influence the other the two dimensions, since project’s timing might not fit in the overall plans of the stakeholders. Stakeholders’ relative attitudes and behavior can be time dependent. At the bottom of the graph are the ERP project phases which are influenced by the internal stakeholder network. for ERP project providing tools management while the other research focuses on how the new ERP system influences the organization prior to and after a decision to launch an ERP project in one or several business divisions. CASES AND RESEARCH METHOD Method to is The research model’s objective describe an ERP project’s key internal stakeholders and their relations. Although the research is focusing on the internal stakeholders, the model includes also the stakeholders from the Business and Company organizations who are assumed to have a key role in an ERP project. The model’s internal stakeholders are defined as the key project organization members and those business organization and company management members who are involved almost full time with the project (Figure 1).Are also considered as internal stakeholders Key Users which are specialists from the line user organizations with process knowledge, and who are assigned almost full time to the project. The circles with the stakeholder name in the middle indicate the key stakeholders, the lines their relations and the arrow heads of the lines the direction of communication Motivators and drivers influence the Stakeholders Stakeholders influence each other Busines s Mgmt Local Mgmt Strength and type of relationship CIO CTO CEO & Board CFO Project Mgr Process owners Project Team Key Users Bus. Process Specialist Stakeholders influence the ERP Project and its phases ERP Project & High-Level Phases 1. Project Initiation 2. Planning 3. Execution 4. Closure Operations & Support Iterative Iterative Iterative Iterative Figure 1: Internal stakeholder’s network, stakeholders from the Business and Company organizations, and ERP lifecycle Cases large The research focuses on three company-wide ERP projects three at companies with headquarters in Finland, which have already implemented ERP systems ranging from thousand to several thousands of ERP users; all interviewees and most companies required to stay anonymous. Project 1 was in a state owned company which sells services to consumers. The company some manufacturing has operations to produce the machines which are used to sell the services. There are approximately 1500 employees the in company. The market where the company is operating is fairly stable, in other words no major changes happen in its business environment. Prior to the unifying project start, there were more than 50 different ERP systems or procedures in use. Project 2 is in a large international process- industry company which operates in more than 30 countries and has nearly 10 000 employees. The company transformed its business from local to the international markets in the past decade. In the recent years the company has focused on moving away from mass-produced towards value- added products and services to increase its competitiveness. Increasing globalization requires more efficient and flexible processes, which is one of the main reasons for the ERP project. Project no 3 is in a large international business-to-business company manufacturing high-tech products. The company has grown fast in the past decade and the expectations for future growth are very positive, although the market is very competitive. The number of employees in the company is over ten thousand and the company operates than 50 in more countries. To face the future growth the management saw that there was a need for company-wide unified processes supported by an end-to-end ERP solution. All of the main the projects cover processes, such as finance and controlling, demand planning and manufacturing, sales and logistics etc. In all of the projects the chosen ERP solution is SAP. However the research is not aiming at developing a model for only SAP projects but the purpose is to develop a general model, which can be utilized regardless of the chosen ERP software. The companies in which the systems have been implemented differ heavily from each other. The differences between the companies are seen as strength for the research rather than a weakness, since this enables to gather relational and communications data from three different organizational environments. This should improve the validity of the results making the end results applicable for various ERP projects. The research population is made of the key internal ERP project stakeholders in the three different projects, completed with stakeholders external to the three deployment including companies, representatives from two ERP-software providers (IFS Finland and SAP Finland) and from a systems integration consultancy company (Accenture Finland). It was not seen necessary to interview all the stakeholders that were involved in the project. It is believed that by interviewing initially identified key stakeholders a fairly reliable model of the stakeholders and their relations can be built. This model was then validated by the external stakeholders mentioned above. The objective was to reach a high level of external validity so that the model can be utilized in future ERP projects regardless of the organization. See Figure 2 below for the entire cycle the till from interviews creation of the generic model, and Figure 3 to get details of the interviewed internal stakeholders’ roles in each case. Internal Interviews Internal Validation Aggregated Data per Project External Validation Analysis per Project Aggregating Data General Model Iteration Iteration Iteration 2: Figure methodology Experimental - Quantitative - Quantitative (SNA Tool) (Frequency) - Qualitative - Qualitative (Interview Data) (Interview Data) research Internal Stakeholders External Stakeholders Project 1 Project 1 Project 2 Project 2 Project 3 Project 3 IFS IFS Finland Finland SAP SAP Finland Finland Accenture Accenture Finland Finland In te rv iew 1 In te rv iew 1 P ro jec t Mg r P ro jec t Mg r In te rv iew 2 In te rv iew 2 P ro jec t Mg r P ro jec t Mg r In te rv iew 3 In te rv iew 3 G loba l Ro l lou t G loba l Ro l lou t Manage r Manage r In te rv iew 4 In te rv iew 4 P rocess P rocess Owne r Owne r In te rv iew 5 In te rv iew 5 Bus iness Bus iness Owne r Owne r In terv iew 6 In terv iew 6 P rocess P rocess Ow n e r Ow n e r In terv iew 7 In terv iew 7 P rocess P rocess Ow n e r Ow n e r In terv iew 8 In terv iew 8 P ro jec t M g r P ro jec t M g r n o i t a d i l a V In terv iew 9 In terv iew 9 Consu l t ing Consu l t ing Se rv . D i rec to r Se rv . D i rec to r In te rv iew 10 In te rv iew 10 Bus . Consu l t ing Bus . Consu l t ing D i rec to r D i rec to r In te rv iew 11 In te rv iew 11 Consu l tan t Consu l tan t In te rv iew 12 In te rv iew 12 Consu l tan t Consu l tan t Figure 3: Internal and external ERP stakeholder roles and distribution of interviewees across projects The boundaries of the research population are tied to the ERP project boundaries. This means that it only consists of persons who have been deeply involved with the project, in most cases full-time project members. As described above to map out relations, the identified key stakeholders are asked to further suggest who else should be to interviewed. According Laumann, Marsden and Prensky (1999) this is called a “realist approach”. A realist approach focuses on actors and boundaries as perceived by the actors themselves. Information collection The main objective is to get a description of all the relations each interviewee had with other stakeholders. However, the interviewee is not only asked to describe his or her own contacts but to also identify relations between other stakeholders that he/she was aware of. The interviewee is then asked to further describe the nature of the relationship, how frequent the interaction was, what kind of interaction it was, who reported to whom, from whom did he/she get input to his work, to whom did he/she give input, was the relationship equal or did either party have more influence in the relationship, which were the most critical relationships from his/her point of view, which relationships lead to conflicts, and finally if the interviewee had recommendations on how to improve the project organization. Also any other comments the interviewee had were recorded. To improve the validity of the results each interviewee who has been involved in a given project is asked to comment on the results from the others preserving anonymity. Figure 4 shows how a graph from an interview looks like; it is drawn in Microsoft Visio. The “circles” indicate the stakeholders, the lines between the circles the relations, the arrows the direction of the relationship, the texts the intensity or frequency of the relations, the circles in grey the most critical stakeholders the interviewee identified, and the red lines the relations with conflicts. The interviewee is also asked to describe the strength of influence and the direction of the relation for those relations where the interviewee is able to give these values. The strength of influence is measured on a scale from 0 to 3, 0 being no influence, 1 being some influence, 2 strong influence and 3 very strong influence. D e v e l o pm e n t team G l o b a l T ra in ing & D o c um e n t a t i o n da i l y da i l y So lu t ion Ow n e r B u s i n e s s P r o c e s s Ow n e r T e c h n i c a l G loba l S tee r ing G r o u p ( in c . C IO ) P rog ram M a n a g e r da i l y Global Rollout Mgr da i l y da i ly da i ly PMO 1 x m o n t h (p h o n e /o n - s ite ) L o c a l S tee r ing G r o u p da i l y G loba l P r o j e c t M a n a g e r In teg ra t ion Sk i l ls C e n t r e P r o c e s s Spec ia l is ts P e r s o n a l re la t ions to Lo ca l P r o j e c t M a n a g e r A n d s om e l o c a l bu s ine s s spe c ia l i s t s O ld co l league s Lo ca l T ra in ing & D o c um e n t a t i o n Lo ca l P ro jec t M a n a g e r L o c a l B u s i n e s s Spec ia l is ts K e y U s e r s Figure 4: Example of stakeholder interview graph an internal To analyze the project’s social network the relation graph drawn in the interview must approach is to analyze the interview data with a qualitative method involving having each interviewee state other stakeholder’s criticality. The two the results of approaches are compared against each other. The Degree of Centrality gives the number of links each node has, in other words how many relations each internal stakeholder has (Answers, 2007). Normally the more connections a stakeholder has the more important he is; but what matters rather is with which other this stakeholders stakeholder has relations which are the most important! Table 1 shows the Degree of Centrality per stakeholder role for all the three projects. The first column shows the project second the role, stakeholder Degree-column the absolute number of relations the stakeholder has, and the third column the Relative Degree of Centrality value in %, which is the ratio of the absolute Degree of Centrality to the maximum possible number of relations which the stakeholder could have (ego density), excluding the stakeholder himself. be transformed into a form suitable for analysis. A sociomatrix (Wasserman and Faust, 1994) is the data structure used to analyze the SNA data. A sociomatrix is created per project based on the graphs drawn like Figure 4 (which exist per project). The sociomatrix data, with the relation strength data, are entered into a commonly used Social Network Analysis tool, UCINET (Analytichtech, 2006). The UCINET data file can be entered into a SNA tool called NetDraw software (Analytichtech, 2006) which draws the the network, stakeholder including stakeholders, their relations and the strength of the relations. UCINET is also used to analyze and filter the data based on different predefined SNA formulas. After all the projects have been analyzed and the patterns have been identified, a generic model stakeholder internal ERP o f relations, combining data from all three projects, has been created with simple combination majority logic. ANALYSIS Stakeholder Criticality This Section is analyzing the stakeholder criticality different two combining approaches. The first approach is to use purely quantitative SNA methods to second the criticality; the evaluate Project 2 Project 3 Project 1 Stakeholder Project Manager Program Steering Group Vice President Business Organization Mgmt Process Owner Program Manager Board Development Team Technical Team Integration Team Local Specialists Key Users Users Re la t ive Deg ree Deg ree 10 83.333 6 50.000 5 41.667 5 41.667 5 41.667 4 33.333 3 25.000 3 25.000 3 25.000 3 25.000 2 16.667 2 16.667 1 8.333 Re la t ive Deg ree Deg ree 15 71.429 10 47.619 10 47.619 9 42.857 9 42.857 7 33.333 5 23.810 5 23.810 5 23.810 5 23.810 5 23.810 4 19.048 4 19.048 3 14.286 2 9.524 2 9.524 2 9.524 2 9.524 1 4.762 1 4.762 1 4.762 1 4.762 Stakeholder Business Process Owner Program Mgr Global Rollout Mgr Global Project Mgr Development Team Technical Mgr Local Steering Group Global Training & Docum. Local Project Mgr Solution Owner Local Business Specialists Local Training & Docum. Integration Team Global Steering Group Financial Services Controller Community Group Controller Key Users Financial Mgmt PMO FiCo Owner Group IFRS Team Stakeholders Solution_Owner Business_Deployment_Mgr Project_Manager Process_Owner Business_Owner_1 Program_Manager Sub-process_Owner Integration Manager Business_Owner_2 Other_Line_Org._Stakeholders Vice_President Program_Steering_Group Regional_Solution_Owner Country_Manager CIO Business_Owner_3 Key_Users Business_Owner_4 CFO Fi_&_Co_Project_manager Configuration_Team Program_Mgmt_Office Operative Board Table 1: Stakeholder Internal ERP centrality degree (absolute and relative) In Project 1 the Project Manager stands out from the rest of the stakeholders. The Project Manager has a total of ten relations out of 12 possible relations, giving Relative Degree of Centrality of 83,3 %, that is a very central position in the project. The following two stakeholders are the Program Steering Group with 6 relations, having 50% of possible relations, followed by the Vice President with 5 relations and 41,7% of possible relations. As expected the Key Users, Local Specialist and Users have the least connections in the project, influencing their importance for the overall program. In Project 2 the Business Process Owner has the most relations, which is explained partly by the fact that the interview data included Finance and Controlling Process stakeholders who influence the Business Process Owner’s decision making. The Degree of Centrality of the Program Manager, Global Rollout Manager, Global Project Manager, Development Team and of the Technical Manager are also clearly visible from the Re la t ive Degree Deg ree 10 45,455 10 45,455 In Project 3 the differences results. 10 45,455 9 40,909 8 36,364 8 36,364 between the stakeholders are not as 7 31,818 6 27,273 6 27,273 6 27,273 significant as in the other two projects; it 6 27,273 5 22,727 4 18,182 4 18,182 4 18,182 was clearly the largest project of the ones 4 18,182 3 13,636 3 13,636 3 13,636 researched so it is natural that there are no 3 13,636 3 13,636 2 9,091 9,091 2 stakeholders that would have relations to almost all other stakeholders. Solution owner, the and Project Manager Deployment Manager had all 10 relations, having 45,5% of all possible relations. The following most central stakeholders were the Process Owner with 9 relations, Program Manager, and Business Owner 1 with 8 relations, and the Sub-Process owner with 7 relations. When comparing the projects against each other it can be noticed that in all of the projects the Project Managers stand high on the list, indicating their importance to the projects. However, when further analyzing the results it can be seen that there are clear differences between them. There can be several reasons for the differences. One explanation could be that the project sizes are different; Project 1 is significantly smaller than Project 3 so it is easier for the Project Manager to have contact with almost everyone making the project organization relatively flat, while the Project Manager in Project 3 simply cannot have relations with all. Another explanation could be that the company cultures differ, so that in Company 1 the culture is more team-work based, while in Company 3 the culture is more top-down- based, meaning that the management gives instructions which go down through different hierarchical levels. The risk of having a “loose” organization is that the communication depends on the stakeholders who have a central role in the communication flow about the project. In connection with the qualitative analysis, the SNA-data were compared to the data from the interviews. During the interviews each interviewee was requested to list the stakeholders that were the most critical for the project; aggregate lists were built and analyzed. Most of the interviewees couldn’t the criticality of the see stakeholders beyond their own relations so they stated the stakeholders that were the most critical from their personal point of view. This can mean that they have missed some very critical stakeholders due to the fact that they did not know exactly what other stakeholders’ role in the project was. The Business Owner role was rated as interviewees, Project critical by 9 of Manager by 7, followed by the Development Team. Similarly the to Program Manager the sponsors, company management, were identified critical by the external interviewees (Figure 3). Even though the other interviewees did not mention the company management as being critical to the project execution, no one disagreed with this statement. The last two who got 2 and 1 votes were the Training Team and the Key Users. Closeness Centrality Closeness Centrality measures how “close” the stakeholder is to the other stakeholders in the network (Wasserman and Faust, 1994). Closeness Centrality is calculated by adding up all the distances a stakeholder has to other stakeholders; a Relative Closeness Centrality value in % can be determined by dividing previous value by total number of stakeholders minus one. By distance is meant how many steps (through other stakeholders) there are from the stakeholder to the other stakeholder in the network (Figure 4). The results of Closeness Centrality analysis support the previous conclusions about the differences between the the projects. The higher Relative Closeness Centrality value is, the “closer” the stakeholder is to the other stakeholders in the project organization. The mean Relative Closeness Centrality for Project 1 is 55,9%: the Project Manager has the highest Relative Closeness Centrality of 85,7% and the Key Users the lowest value of 35,3%. For Project 2 the mean Relative Closeness Centrality is 52,3%, the Business Process Owner having a value of 77,8% and the Key Users the lowest value of 38,9%. The Business Process Owner’s value is again relatively high mainly because of the inclusion of the business process stakeholders in the data. When looking at the values for Project 3, the mean value is 44,8% , the highest 62,9% (Project Manager) and the lowest belongs to the Operative Board with a value of 37,3%. The low value of the Company Board is not surprising since they are not actively involved in the project but get regular status updates from the Vice President who is the only direct contact they have to the project. The conclusion is that the stakeholders in Projects 1 and 2 are significantly “closer” to each other than in Project 3. Again this could be explained by the difference in the project sizes, but when taking the interview data from Project 3’s stakeholders into account, the conclusion that the company culture is top-down based is supported by the analysis results. “Betweenness” Centrality and mediating roles While one stakeholder might have more direct connections to other stakeholders than another it is not the only thing that counts. The stakeholder who has a position between two stakeholders is called a mediator. He/she is passing the message from one stakeholder to the other. A mediator’s position is strong because without him/her acting in between the two stakeholders, these couldn’t communicate with each other. According to Krebs (2006), a mediator actor, which has high “Betweenness”, has great influence on what flows within the network. Betweenness Centrality is calculated by looking at all the paths between all the stakeholders and calculating how many of those go through the specific stakeholder in quest ion (Wasserman and Faust, 1994); a Relative value can be determined by dividing the previous value by the number of stakeholders in the network minus one. When first analyzing Project 1 it can be seen that the Project Manager has clearly the highest Relative Betweenness Centrality value (41), indicating that he/she is the central mediator in the project. The Key Users are surprisingly on the second place in the list, but when looking at the aggregated graph from Project 1 the reason for their high position in the statistics gets clear: they are acting between the rest of the project organization and the end Users. In Project 2 the Business Process Owner gets the highest Relative Betweenness Centrality value of 100,5 , followed by the Program Manager with 29,1; the first high value is explained by the role as a mediator between the business process stakeholders and the project organization. When analyzing the Project 3 Betweenness values it can be seen that no stakeholder has as high values as in the other two projects: the the Solution Owner has highest Relative Betweenness Centrality value of 38,1 followed by the Business Deployment Manager (29,3), Business Owner (27), Project Manager (26,4), Process Owner (25,8) and the Program Manager (22,6). What is interesting in the results of Project 3 is that almost all stakeholders have some kind of mediator posit ion. The results indicate that this project organization is more resistant to failures in the communication than in the other projects. Bottleneck roles A bottleneck is a process or stakeholder in any part of the organization that limits the throughput of the whole process (QMI Solutions, 2007). In an ERP project a potential bottleneck is a person who is also acting as a mediator between two parties. The Relative Betweenness Centrality values from the SNA-analysis maximized across projects shown in Table 2 give a good indication whether a person could be a potential bottleneck or not; are selected the stakeholder roles with the highest Relative Betweenness Centrality values. # S takeh o l der B e tw e en ne ssPro j ec t 1 B u s i n e s s P r o c e s s O w n e r 1 0 0 , 5 1 9 P r o j e c t 2 2 P r o j e c t M a n a g e r 4 1 P r o j e c t 1 3 S o l u t i on _ O w n e r 3 8 , 1 3 2 P r o j e c t 3 4 B u s i n e s s _ D e p l o y m e n t _ M g r 2 9 , 3 3 7 P r o j e c t 3 5 P r o g r a m M g r 2 9 , 1 4 P r o j e c t 2 6 B u s i n e s s _ O w n e r _ 1 2 7 , 0 2 7 P r o j e c t 3 7 G l o b a l R o l l ou t M g r 1 6 , 6 4 3 P r o j e c t 2 8 L o c a l B u s i n e s s S p e c i a l i st s 1 6 , 5 8 3 P r o j e c t 2 9 G l o b a l P r o j e c t M g r 1 5 , 3 9 3 P r o j e c t 2 1 0 I n t e g r a t i on M a n a g e r 1 2 , 7 9 2 P r o j e c t 3 Table 2: Highest Relative Betweenness Centrality Results The most interesting detail is that the Business Process Owner, Project Manager and the Deployment Manager are all in the top of both the SNA analysis and the qualitative critical stakeholder list built by the interviewees. The SNA analysis results were not shown to the interviewees. This is why it can be said with a fairly high reliability that the Business Process Owner has the highest probability of becoming a bottleneck, followed by the Project the Local Deployment Manager and Manager. Three out of the top four bottlenecks roles are caused by a person at a managerial level. Conflicts As discussed in the literature review all stakeholders interpret the value of the project in their own way. The owners and users typically want to have as wide a scope as possible, the project staff wants to define the scope as accurately as possible and to freeze the design as early as possible, the finance managers look at the costs and the return on investment, and the top management looks at it from the company strategy perspective (Walsham, 1993). The only way to solve these conflicting objectives is to negotiate with all stakeholder groups until a consensus is reached (Remenyi, 1999). Table 3 shows the data for the identified conflicts stakeholders, the between aggregated across projects and roles. The first three conflicts are internal conflicts within the project organization, while the Conflicts numbered from 4 to 10 are mainly between the business organization and the project organization. Conflict 9 the Business incurs mainly between Owners. The first column states the stakeholders who are involved in the conflict, the second column describes the conflict, followed by information on in which of the three interviewed projects the conflict was identified, the possible consequences of the conflict and finally recommendations on how to mitigate the risk of the conflict. Most of the conflicts are related to how well the redesigned business processes and the new system are able to meet the business’s requirements. Since one of the main objectives of a company-level ERP project is, in most cases, to harmonize the business processes within the company it means that many Business Units and especially the local business organizations need to change the way they are working currently. This causes natural resistance in the Business Units and local business organizations. As in any complicated projects where there are many stakeholders involved, the communication clear of importance procedures, roles and channels are highlighted. Whether the communication happens inside the project organization or between the business and the project organizations, in all cases clear rules, roles and procedures must be set up. In most of the Conflicts (e.g. numbers 2, 4, 5, 6, 8, 9) the root reason for the conflict is that either parties (or both) feel that their needs and opinions are not taken into account well enough. It can be the case that some requests are not taken into account because they seem difficult to accommodate, but it might also happen that the other party doesn’t know the requirements well or the argumentation behind them. Clear and fluent communication between the parties would enable to solve the conflict faster. If the problem escalates and the parties are not able to communicate well with each other, there should be a mediator between them. Quite often the Program or the Project Manager has to act as a mediator between two arguing parties. Stakeholders Involved Conflict 1: - Solution/Concept Owner (Process 1) - Solution/Concept Owner (Process 2) - Process Owner (Process 1) - Process Owner (Process 2) - Project Manager Conflict 2: - Solution Owners - Development Team - Project Manager Conflict 3: - Project Manager - Project Members from the internal organization - External Consultants Conflict 4: - Business Owners - Local Business Managers - Program Manager Conflict 5: - Program Manager - Project Manager - Business Owner/Business Organization/Process Owner Conflict 6: - Local Steering Group/Local Country Management - Global Deployment Manager - Local Deployment Manager - Program Manager - Program Steering Group Conflict 7: - Local stakeholders (Local Steering Group, Steering Group, Business Managers, and Business Managers, Business Process Specialists) changes their Possible Mitigation plan Business Process requirements after the deadlines for Consequence (How to control changes have been met. This causes a Specialists Conflict Description risk) Identified conflict between the project teams who are - Solution Owner Negative impact on Improve Project 3 Solution specifications: involved with designing and building the - Development Team schedule Solution Owners disagree about specific communication system (Dev. Team, Solution Owner, - Global Deployment cross-process solutions in the ERP system. between teams Technical Team) and the Local Business Manager The goals of Finance and the Sales process Organization. If the conflict escalates the - Technical Team Solution Owners could differ from each Program Management and the Steering - Program Manager other in some cross module areas causing Group have to react on it. Even the - Program Steering arguments between them. Project Manager Process Owner might get involved. Group has to mediate between the Solution - Business Process Owners. The conflict might escalate up to Owner the Process Owners. Business Processes Change Resistance: Conflict 8: Negative impact on Improve Project 3 Solution specifications level of detail: The Program Management wants to - Local Steering schedule communication Arguments of the level of detail of the streamline the global business processes so Group/Local Country between teams solution specifications. Development team that one solution would fit all. The local Management finds the level too high and the Solution business organization resists the changes - Business Owners Owners believes it is detailed enough and doesn’t see the project bringing any - Global Deployment Negative impact on Ensure the skill Project 1 Skills do not meet expectations: benefits for them (which might be the Manager schedule (and level before The external consultants’ skills and case). Business Owner does not support - Local Deployment contract (if quality) experience do not meet the Project the changes and the project. The Program Manager possible) Manager’s expectations. The reason for Steering Group has to interfere and - Program Manager the conflict is that the external consultancy possible escalate the issue even higher - Program Steering company sells the resources to the client (CEO) to get the local business Group even though knowing that they are not organization and the Business Owner to - Process Owner skilled enough. support the projects. Negative impact on Improve Project 3 Forming Program Steering Group: Conflict 9: Business Processes Change businesses’ Issues in forming the Program Steering communication - Business Owner from Disagreements: between business Group. Some business organizations (e.g. commitment Business Unit 1 The Business Units’ managers (Business Local Business Managers) see that they units about the Owners) argue about the new to-be - Business Owner from are not represented in the Steering Group. program business processes, schedule, scope, Business Unit 2 objectives. Arguments between the Business Owner budget etc. due to different business needs. - Program Steering Escalate problems and the Local Business Managers. Group The Program Steering Group is involved Arguments between Business Owners. on time to higher in the discussion, since most Business management. Owner are members of the Steering Group. Negative impact on Communicate to User Resistance of Change: business the schedule and quality Key Users or Users resistance to change impact if needs because of fear of loosing power. not met. Escalate the issue as early as possible to Steering Group Project 1 Resource Allocation: Conflict 10: Arguments about project resource - Local Deployment allocation. Project needs resources from Manager/Team the Business Organization. Business - Key Users/Users Owner doesn’t see the benefit of allocating the resources, which causes a conflict between the stakeholders State project Negative impact on Project 2 Project Scope or Solution Design: Local Country Management wants organizations businesses’ Accenture Table 3: Identified conflicts amongst roles and commitment SAP changes in the solution. Local Deployment responsibilities Manager promises changes to please the internal ERP stakeholders local management. The changes are not in clearly. Improve communication line with the global project objectives, When aggregating the conflicts into a risk procedures to which causes a conflict between the program management (Global Deployment avoid escalation matrix with impact factors, the highest risk Manager, Program Manager, Program Steering Group) and the Local Country for an ERP project is caused by resistance Management (Local Steering Group, from the Business Owners (Conflict no. 8) Country Manager) and the Local Deployment Manager. therefore and the business local Negative impact on Project 2 Communicate the Changing Requirements: Local Business Organization (Local deadlines better to schedule organization. The next highest risk is the resource allocation Conflict no. 5 which includes a conflict between the Business Owners. Relational Ties The social linkages between the actors are called Relational ties. The most common Relational tie categories relevant to this research are: formal relations (authority) and behavioral interaction (information sharing), in sum whether the relation is based on authority or a need to get or give information to another stakeholder or both. A matrix was built, based on the interview data, summarizing the relations between the stakeholders and explaining which type of the tie exists between relational stakeholders. Each column represents the stakeholder’s (first row on the X-axis) relationship with the stakeholders on the Y-axis and the binary type of relational tie. “A” stands for official authority, meaning that the stakeholder has an authority over the other stakeholder; “B” is a relation which is based on information sharing, neither having official authority over each other. The Program Manager was found to have the most relations with official authority (“A”), followed by the Project Manager. The lower the stakeholder is situated in the organizational hierarchy, the more the relations were found to be based on information sharing (“B”). The Deployment Manager and the Deployment Team have the most relations which are not based on authority but on changing information. This is a logical result since they have to act with both the project organization and local business the organization stakeholders. Another way of the real looking at authority in the network is to look at the strength of the relationships identified by the interviewees. The matrix mentioned before can be populated with the strength of influence the stakeholders have over each other (as collected in Figure 4), yielding the Relationship Strength matrix. It was found that the official authority (“A”) and strength of the relation are strongly tied together. However it must be noticed that there are certain stakeholders who have, most likely because of specialist position, a high relation strength value, for instance the Development and Training teams. The Deployment Team’s high value is explained by the fact that it has the most influence on the Key Users and the Users in the local organizations. Besides, the results have indicated that an ERP project has relatively equal relations based on information sharing (“B”) between the internal stakeholders. Cliques A clique is a group of actors in which all actors have relations to all other actors. A clique has always a minimum of three nodes. By studying cliques we can identify tight groups within the ERP project internal stakeholder network. Some argue that the definition of a clique is too strict since it requires that everyone within a clique has a relation with everyone else, which is not always the case in real life environments (Wasserman and Faust, 1994). However, it still gives some picture of which subgroups exist within the network and that is why cliques were identified in this research. When analyzing the Project sociomatrices with UCINET, or using the actor-by-actor clique co-membership matrix, in total 6 cliques were found in Project 1, 16 in Project 2, in Project 3, and 20 corresponding to increasing organizational spread. Generic Internal Stakeholder Network Model After having identified the most common internal ERP project stakeholders, the relations between them and the strength of their relations, a generic Internal Stakeholder Network model was built. The graph in Figure 5 below is a result of the entering the Relationship Strength matrix in NetDraw (Analytichtech NetDraw, 2006) software. It shows the key internal ERP project stakeholder roles, the relations between them and the strength of these relations in both directions. 2.0 1.0 1.0 2.0 1.0 DevelopmentTeam 1.0 1.0 3.0 2.0 Deployment ManagerDeployment Team 2.0 1.0 2.0 1.0 1.0 2.0 1.0 1.0 2.0 2.0 1.0 2.0 2.0 2.0 Key Users 3.0 2.0 2.0 2.0 2.0 3.0 1.0 2.0 Training Team 1.0 1.0 1.0 3.0 2.0 2.0 1.0 2.0 2.0 1.0 1.0 2.0 2.0 2.0 1.0 1.0 2.0 3.0 Integration Team 2.0 2.0 1.0 1.0 1.0 2.0 2.0 2.0 2.0 1.0 Technical Team 2.0 1.0 1.0 1.0 2.0 1.0 1.0 1.0 1.0 1.0 1.0 1.0 Solution Owner 2.0 2.0 2.0 1.0 2.0 2.0 3.0 1.0 Project Manager 2.0 1.0 2.0 2.0 2.0 1.0 1.0 1.0 2.0 1.0 1.0 1.0 2.0 Program Manager 3.0 1.0 2.0 2.0 1.0 3.0 PMO 2.0 1.0 3.0 2.0 1.0 3.0 3.0 Process Owner 1.0 1.0 1.0 Users 2.0 3.0 1.0 Business Stakeholders 2.0 1.0 1.0 Local Country Manager 3.0 2.0 1.0 Business Owner 2.0 2.0 3.0 Steering Group Figure 5: Generic Internal ERP project Stakeholder Network Model; the strength of influence is measured on a scale from 0 to 3, 0 being no influence, 1 being some influence, 2 strong influence and 3 very strong influence. This model is based on the interview data. A few relations that were not mentioned by the internal interviewees but were seen as highly likely to have appeared, have been added to the data, but only after confirming the possibility of the relation with the external interviewees. The interview data included strength data for most of the relations. Since the interviewees did not determine a numerical value for the Steering Group’s relation strengths the value was given by the researchers based on the external interviewees’ comments about the Steering Group. Stakeholder Drivers According to Herzberg (1959), responsibility, advancement, work itself and recognition for achievement are important for every employee because they indicate how competent a person is. The positive drivers were found to be in line with most IS projects. The negative drivers are the reasons that make the stakeholder resist something, in this case the ERP project. The negative drivers are found to be often fear-related, meaning that the stakeholder is afraid that the project’s outcome is against his own best interest, such as decreasing his power in the organization (see the Survey section). It was observed that the stakeholders who were against the projects came in most cases from the business organizations, and not from within the project organizations. Stakeholder Criticality per Project Phase One of the objectives of this research was to discuss stakeholders internal the influence on each project phase (Feasibility Study, Planning, Analysis, Design, Build, Test, Deploy and Hand-over to the support organization (Westland, 2006). In the Feasibility Study phase very few internal project stakeholders are involved except company management (CEO, CFO, CIO etc.) and the high level Business Unit management; in that phase the company management is the critical stakeholder group. More people join the project when the planning phase starts; at this stage the Program Manager, the Process Owners and the Business Owners are critical stakeholders. When the project evolves more stakeholders get involved with it: the Project Managers, Solution Owners and the Development Team become important. The Training Team and the Key Users’ importance increases when the system is about to be implemented in the local business organizations. RECOMMENDATIONS FUTURE ERP PROJECTS FOR Based on the experiences of past ERP projects, such as the three case studied in this several are there research recommendations that are suggested for future ERP project implementations. Some of them are generic project management advice and others suggestions about tools that could be used to mitigate some of the risks related to the internal stakeholders and their relations. Business Process Redesign  Ensure sufficient time for business process design and clarify the importance of proper design to the company management. The ERP system is built based on the business processes, which means that the processes are not if designed properly the system will not work properly either causing the project to miss its objectives. Internal Stakeholder Motives broad and  Develop efficient for internal incentive programs to ensure project stakeholders everyone’s full commitment to the project and reduce power confrontations. Project Progress  Develop electronic real-time tools to track the progress of each stakeholder group to in order address issues on time. Such tools should include the real time analysis by SNA of email, Mobile email, SMS and Instant messaging traffic (not content); this real time capability would e.g. immediately spot bottleneck roles over time. Since the teams are dependent on each other’s input/output, the progress is extremely tracking important. Communication, Bottleneck and Conflict Resolution: Increase the number of stakeholder  relations and the communication flow by encouraging the use of messaging the tools within project’s stakeholder network to enable to stakeholders the communicate better with each other. This improves the projects creates “Closeness Centrality”, more relations between the stakeholders, them bringing “closer” to each other. The risk of communication bottlenecks and conflicts is reduced. If allowed/possible, track the usage of the instant messaging tools and emails to gather information on the stakeholder relations and Relation Strength  Analyze the usage of the project’s shared document libraries, issue resolution tools etc. to gather knowledge of the activity level of the stakeholders and stakeholder cliques.  Use SNA tools to visualize the stakeholder network and the real- time relations. Visualization helps to reveal possible bottlenecks or  in the weak points (mediators) organization.  React immediately if there is lack of communication flow and density in the project  Develop an efficient Governance Model, which defines the roles and responsibilities together with appropriate communication and issue resolution channels  Organize common events to “weld” the stakeholders better together. Role Staffing  Ensure that the most critical roles identified research are this in staffed with people who have the correct skills and experiences. CONCLUSION The main conclusions, which can be utilized when planning new ERP projects, are the following: 1. ERP project’s general stakeholders can be categorized in three groups: Project Organization, Business Organization and Company Management stakeholders. The Project Organization consists of the internal stakeholders who work the project. The for full-time Business organization consists of people who are influenced by the business process redesign and the new ERP system, and some are also internal to the project. Company Management consists of stakeholders who have stakes in the ERP project outcomes at business and/or operational level, such as the persons who decided to launch the project in the first place. interviews, the to 2. According supported by the SNA analysis, the internal stakeholders who are the most critical for an ERP project outcome are the company management Business Owner, Process Owners, the Deployment Manager, and the Solution Owner. 3. The internal stakeholders can be further divided into those who are the higher responsible of level planning and coordinating (Program Manager, Business Owner, Process Owner) and those who in the plans implement practice (Project Manager, Solution Owner, Development Team and Deployment Manager). 4. Next to the different criticality measures determined from the interview data, the Social Network Analysis another provided interesting metric for analyzing the criticality of stakeholders in their network, the Closeness Centrality. The quantitative SNA results suggest that the Process Owner, Project Manager, Deployment Manager and Solution Owner are the internal stakeholders who have the most central roles in the project meaning that they have short paths to other stakeholders. These stakeholders should be utilized for communication and conflict solving purposes since the they have shortest and fastest connections to others. When considering communication it is important to have direct connections to the timely and receivers to ensure accurate messages. The same applies for conflict solving. The person who has direct connections to involved parties has higher chances of solving the conflict quickly. 5. Internal stakeholders who act as a bridge between other stakeholders, so called mediators, are extremely important actors in the network having a very strong position in the project. The Project Management should be aware of the risks related to the mediators. If the mediator fails to deliver the message, changes the message on the way, doesn’t bring it on time or even at all, a bottleneck is formed. The following were stakeholders identified as mediators: Project Manager, Process Owner, Solution Owner, Deployment Manager and Business Owner should 6. Project Management understand that the conflicts that have the largest impact on the project’s success derive from the relations between the project organization and the business organization or within the business organizations. The most serious conflicts that endanger the project are caused be business process redesign related issues. If the conflicts the solved are not dissatisfied stakeholders will not support the project and might even try to actively resist it. 7. To ensure everyone’s commitment towards the project the personal objectives should be tied to the project’s objectives. Each internal stakeholder thinks first “what is in it for me?” when they listen to project issues. If they don’t gain anything they will most likely not commit to the project. The incentive plan should be made at least for the most critical internal business organization stakeholders such as the Business Owner. Summarizing the recommendations on a general level, the Project Management should not ignore the sociological aspect of the ERP project implementation, and should not think that these aspects cannot be analyzed or monitored as shown in this paper. Too often the main focus of the Project Management is on the system and its design. Each project is slightly different but there are many similarities between them. If the above recommendations are followed some of the major project risks can be, if not fully avoided, at least minimized. The above research results, and the generic internal network stakeholder ERP characteristics studied here, are also very useful for the progress in parallel research on business genetics which models the different forces whereby business units collaborate on an ad-hoc basis inside smart business networks, with fast connects and disconnects relying on ERP systems (Pau, 2006; Pau, 2008). Furthermore, one of the authors has developed specifically for ERP projects an add-on software enabling the real time social network dynamics to be analyzed work respecting while assignments and processes. REFERENCES Al-Mashari, M., “Constructs of Process Change Management in ERP Content: A Focus on SAP R/3”, Proceedings of 2000 Americas Conference on Information Systems AMCIS 2000, Long Island, 2000, pp. 977-980 Analytichtech , Ucinet 6.150, http://www.analytictech.com , 2006 Analytichtech, NetDraw 2.049, http://www.analytictech.com , 2006 Answers, “Eigenvector Centrality”, January 14, 2007, http://www.answers.com/topic/eigenvector -centrality Bradford, M. and Richtermeyer, S. “Realizing value in ERP”, Journal of Cost Management, March/April, 2002, pp. 13- 19 Burkhardt, M. E. and D. J. Brass, "Changing Patterns or Patterns of Change: the Effects of a Change in Technology on social Network Structure and Power", Administrative Science Quarterly, vol. 35, No., 1, 1990, pp. 104 Butcher, D. and Clarke, M. “Organizational politics: the missing discipline of management?” Industrial and Commercial Training Volume 31, Number 1, 1999, pp. 9–12 Darwin’s Executive Guides, “Enterprise Resource Planning”, December 28, 2004, http://guide.darwinmag.com/technology/en terprise/erp/index.html Davenport, T., “Putting the Enterprise into the Enterprise System”, Harvard Business Review, July-August 1998, pp. 121-131. Dhillon, G., “Dimensions of power and IS implementation,” Information & Management 41, 2004, pp. 635-644 Hellens, L., Nielsen S. and Beekhuyzen J., “Qualitative Case Studies on Implementation of Enterprise Wide Systems,” Hershey, Idea Group Publishing, 2005, Chapter IX, pp. 212-238 Herzberg, F., Mausner, B. and Snyderman, B. B., “The motivation to work”, New York, John Wiley & Sons, 1959, pp. 113- 120 ITtoolbox, “Influencing Stakeholders”, Adapted from ERP-Project Management discussion group by ITtoolbox Popular Q&A Team, March 20, 2006, http://erp.ittoolbox.com/documents/popula r-q-and-a/influencing-stakeholders-3823# Keen, P., “Information Systems and Organizational Change,” Communications of the ACM, 24/1, New York, ACM, 1981, pp. 24-32. Koch, C., “It’s Time to Take Control”, Issue of CIO Magazine, July 15, 2002, http://www.cio.com/archive/071502/contro l.html Koch, C., “Hershey’s Bittersweet Lesson” Issue of CIO Magazine, Nov. 15, 2002, http://www.cio.com/archive/111502/tl_her shey.html Komiega, K., “The ABC’s of ERP”, Oct. 8, 2001, http://searchcrm.techtarget.com/tip/1,2894 83,sid11_gci760534,00.html Krebs, V., “An Introduction to Social Network Analysis”, 2006, http://www.orgnet.com/sna.html Laumann, E., Marsden, P. and Prensky, D.,”The Boundary Specification Problem in Network Analysis”, Research Methods in Social Network Analysis, Fairfax, George Mason University Press, 1989, pp. 61-87 Markus, M. L., “Power, Politics, and MIS Implementation,” Communications of the ACM, 26/6, ACM, 1983, pp. 430-444. Markus, M. L. and Pfeffer, J., “Power and the Design and Implementation of Accounting and Control Systems”, Accounting Organizations and Society, 8/2, 1983, pp. 205-218. Nah, F.F., Lau, J.L. and Kuang, J., “Critical factors for successful implementation of enterprise systems”, Business Process Management Journal, Vol. 7, No.3, pp. 285-296. Newman, M. and Rosenberg, D., “Systems Analysts and the Politics of Organizational Control,” International Journal of Management Science, 13/5, 1985, pp. 393- 406. Pau, L-F, “Smart business network design and business genetics” , Research report ERIM, Rotterdam school of management , Feb. 2006, http://hdl.handle.net/1765/7319 ; also in: P. Vervest, E. Heck , K. Preiss (Eds), Smart business networks: a new business paradigm, Chapter 15, pp 218- 240, ERIM and SBNi, 2008, ISBN : 978- 90-5892-159-8 Pau, L-F, “Smart business networks : architectural aspects and risks”, in S. Nurcan, R. Schmidt , P. Soffer (Eds), Proc. 9 th Workshop on Business process modeling , development and support “Business process life-cycles”, in conjunction with CAISE 08 Conference , Montpellier, June 16-17, 2008, pp 130-137 , ISSN 1613-0073, CEUR Workshop proceedings Vol 335, http://CEUR- WS.org/Vol-335 Walsham G, “Interpreting Information Systems In organisations”, New York, John Wiley & Sons, 1993 Wasserman, S. and Faust, K., “Social Network Analysis: Methods and Applications”, New York, Cambridge University Press, 1994, pp. 43-75. Westland, J., “The Project Management Life Cycle: Complete Step-by-Step Methodology for Initiating, Planning, Executing & Closing a Project Successfully” London, Kogan Page, 2006, pp. 15-43 Worthen, B., “Nestl(cid:133)’s ERP Odyssey”, Issue of CIO Magazine, May 15, 2002 http://www.cio.com/archive/051502/nestle. html QMI Solutions, “Glossary of Terms”, 21st January, 2007, http://www.qmisolutions.com.au/article.as p?aid=116 Rao, S. S., “Enterprise Resource Planning: Business Needs and Technologies”, Industrial Management & Data Systems 100(2), 2000, pp. 81-88 Remenyj, D., “IT Investment: Making a Business Case” Butterworth-Heinemann, 1999, pp. 103-149 Rice, R. E. and C. Aydin, "Attitudes toward New Organizational Technology: Network Proximity As a Mechanism for Social Information Processing", Administrative Science Quarterly, Vol. 36, 1991, pp 219-244 Robb, D., “SAP deployments: Pain for gain” Computerworld, September 4, 2006, http://www.computerworld.com/action/arti cle.do?command=viewArticleBasic&articl eId=9002959 Rowley, T., “Moving beyond Dyadic Ties: A Network Theory of Stakeholder Influences” Academy of Management Review, Vol. 22, No. 4, 1997, pp. 887-910 Savolainen, T., “SAP:n asiakkaat valittavat ongelmista” Tietoviikko, February 21, 2005, http://www.tietoviikko.fi/doc.do?f_id=687 127 Silver, M., Markus, L. and Beath, C., “The Information Technology Interaction Model: A Foundation for the MBA Core Course”, MIS Quarterly Volume 19 No. 3, 1995, pp. 361-390 Torikka, M., “ Baan ja Konecranes p(cid:129)(cid:129)siv(cid:129)t sopuun” Tietoviikko, September 9, 2003, http://www.tietoviikko.fi/doc.do?f_id=494 240
1210.4864
1
1210
2012-10-16T17:39:07
Graph-Coupled HMMs for Modeling the Spread of Infection
[ "cs.SI", "physics.soc-ph", "stat.AP" ]
We develop Graph-Coupled Hidden Markov Models (GCHMMs) for modeling the spread of infectious disease locally within a social network. Unlike most previous research in epidemiology, which typically models the spread of infection at the level of entire populations, we successfully leverage mobile phone data collected from 84 people over an extended period of time to model the spread of infection on an individual level. Our model, the GCHMM, is an extension of widely-used Coupled Hidden Markov Models (CHMMs), which allow dependencies between state transitions across multiple Hidden Markov Models (HMMs), to situations in which those dependencies are captured through the structure of a graph, or to social networks that may change over time. The benefit of making infection predictions on an individual level is enormous, as it allows people to receive more personalized and relevant health advice.
cs.SI
cs
Graph-Coupled HMMs for Modeling the Spread of Infection Wen Dong, Alex “Sandy” Pentland M. I. T. Media Laboratory M. I. T. {wdong, sandy}@media.mit.edu Katherine A. Heller Department of Brain and Cognitive Sciences M. I. T. {[email protected]} Abstract We develop Graph-Coupled Hidden Markov Models (GCHMMs) for modeling the spread of infectious disease locally within a social network. Unlike most previous research in epidemiology, which typically models the spread of infection at the level of entire popu- lations, we successfully leverage mobile phone data collected from 84 people over an ex- tended period of time to model the spread of infection on an individual level. Our model, the GCHMM, is an extension of widely-used Coupled Hidden Markov Models (CHMMs), which allow dependencies between state tran- sitions across multiple Hidden Markov Mod- els (HMMs), to situations in which those de- pendencies are captured through the struc- ture of a graph, or to social networks that may change over time. The benefit of making infection predictions on an individual level is enormous, as it allows people to receive more personalized and relevant health advice. 1 INTRODUCTION Growing amounts of information available from social network data afford us an unprecedented opportunity to answer questions about the individual agents who are represented in these social networks, typically as nodes, via the use of statistical models. The goal of this paper is to provide a framework for modeling the dynamical interactions between individual agents in a social network, and to specifically apply it to modeling the spread of infection. We present the Graph-Coupled Hidden Markov Model (GCHMM), a discrete-time model for analyzing the in- teractions between agents in a dynamic social network. New data and computational power have driven re- cent developments in models of epidemic dynamics, in which individuals in a population can express dif- ferent epidemic states, and change state according to certain events. These dynamics models range from assuming homogeneous individuals and relations [Ker- mack and McKendrick, 1927] to incorporating increas- ingly more information on individuals and their rela- tionships [Eubank et al., 2004, Salath´e et al., 2010, Stehl´e et al., 2011, Hufnagel et al., 2004]. For ex- ample, Eubank [Eubank et al., 2004] predicted out- breaks ahead of time by placing sensors in key loca- tions, and contained epidemics through a strategy of targeted vaccination using land-use and population- mobility from census data. Salath [Salath´e et al., 2010] looked at matching absentee records at a high school with the epidemic size predicted by the susceptible- exposed-infectious-recovered (SEIR) model. In this paper, we focus on modeling the spread of in- fection at an individual level, instead of for an entire population. We aim to predict the state of each indi- vidual’s health, and the paths of illness transmission through individuals in a social network. This informa- tion helps us to understand how disease is transmitted locally within a network, and to give individual-level behavioral advice about how to best maintain good health. The social network data that we employ for this re- search is mobile phone data collected from 84 people over an extended period of time. The data track each person’s proximity to others within the network, and daily symptom reports signal whether individual mem- bers of the network might be ill. Our graph coupled hidden Markov model (GCHMM) incorporates dynamic social network structure into a coupled hidden Markov model [Brand et al., 1997]. A GCHMM allows us to predict at an individual level how the spread of illness occurs and can be avoided. Our results point to a new paradigm of infection con- trol based on sensor networks and individual-level modeling. Access to dynamic social networks is an essential part of modeling the spread of disease, and is useful for many other real-world social applications as well. The study of dynamic social networks has attracted con- siderable research in the machine-learning community [Goldenberg et al., 2010]. Since diffusion within dy- namic social networks is important in many appli- cations, we believe the GCHMM will also be useful for studying the dynamics of fads, rumors, emotions, opinions, culture, jargon, and so on [Castellano et al., 2009]. Even though we focus on epidemiology in this paper, the same model could be applied to determin- ing, for example, to what extent an individual will change his opinion to match the value of a random neighbor in the formation of community consensus [Holley and Liggett, 1975], to what extent an individ- ual will change one of his traits to match the value of a random neighbor using the Axelrod model of culture formation [Axelrod, 41], how a real-world vocabulary is formed at the society level through imitation and alignment at the individual level [Steels, 1995], and for any of these what further implications might be at both the individual level and the network level. This paper therefore makes several novel contributions to the field of human behavior modeling and machine learning: 1) We introduce a new class of models, GCH- MMs, which combine coupled HMMs with dynamic so- cial networks. We inject dynamic social network struc- ture into the CHMM allowing us to use this class of models for a potentially very wide range of multi-agent network or behavior modeling tasks (e.g. rumor, in- novation, or organizational flow in social networks). 2) We specify a particular model in that class, which is a novel model for epidemics. This model allows us to make individual-level epidemics predictions not en- abled by previous epidemics methods. 3) We provide methods for performing inference, generally in the case of 1) and specifically in the case of 2), and discuss how they relate to each other and previous work. These methods provide tools for researchers interested in a broad range of multi-agent and social network appli- cations. 4) We validate our epidemics model on an interesting new dataset which tracks the spread of ill- ness on a local, individual level. The rest of the paper is organized as follows. In section 2 we review the coupled hidden Markov model. In section 3 we introduce the GCHMM for multi-agent modeling in dynamic social networks. In section 4 we show how the GCHMM can be applied to modeling the spread of infection in networks, and in 5 we derive the Gibbs sampler for parameter learning and latent state estimation of the GCHMM for epidemics. In section 6 we apply the GCHMM to our epidemic data from an undergraduate university residence hall, which includes daily symptom reports and hourly proximity tracking. 2 COUPLED HIDDEN MARKOV MODELS A coupled hidden Markov model (CHMM) describes the dynamics of a discrete-time Markov process that links together a number of distinct standard hidden Markov models (HMMs). In a standard HMM, the value of the latent state at time t (Xt ) is dependent on only the value of the latent state at time t − 1 (Xt−1 ). In contrast, the latent state of HMM i at time t in the CHMM (Xi,t ) is dependent on the latent states of all HMMs in the CHMM at time t − 1 (X·,t−1 ). The CHMM generative model is defined as follows: Xi,t ∼ Categorical(φi,X·,t−1 ) Yi,t ∼ F (θXi,t ) (1) (2) where Xi,t is the hidden state of HMM i at time t, Yi,t is the emission of HMM i at time t, X·,t−1 is a vec- tor of the state values of all HMMs at time t − 1, and φi,X·,t−1 is a vector the dimensionality of which is equal to the number of states in the HMM and the entries of which sum to 1. The entries in φi,X·,t−1 represent the probability that the state variable in HMM i will transition from its state at time t − 1 to each possible state at time t, given the states of all other HMMs at time t − 1. θXi,t is the emission parameter for observa- tions that derive from state Xi,t . The graphical model for the CHMM can be seen in figure 1. Historically, inference in CHMMs has been achieved via maximum likelihood estimation, usually using an cause a CHMM with Mi states for HMM i has (cid:81) Expectation-Maximization (EM) algorithm. Special- ized CHMMs are often used in practice, however, be- a (cid:81) i Mi × (cid:81) i Mi states in total, and the state transition kernel φi is i Mi matrix, both of which are a con- siderable size. Many specializations either omit the inter-chain probability dependence, such as in the fac- torial hidden Markov model [Ghahramani and Jordan, 1997, Brand et al., 1997], or introduce fixed sparse inter-chain probability dependence, such as in hidden Markov decision trees [Jordan et al., 1996]. The dy- namic influence model [Pan et al., 2012] allows one chain to probabilistically depend on all other chains through only a few sufficient statistics without increas- ing modeling complexity. However, in the following sections we introduce the GCHMM, which differs from the models described above in considering HMMs that are coupled based We can use the CHMM in conjunction with dynamic network Gt if we let Xn,t be the state of agent (node) n at time t, and Yn,t be noisy observations about agent n at time t. Gt restricts the connections between latent state variables in the CHMM, allowing us to model multi-agent phenomena of interest while potentially al- lowing for efficient inference. The generative model of the GCHMM in its most gen- eral form is as follows: Xn,t ∼ Categorical(φn,Xe:{n,·}∈Gt ,t−1 )(5) Yn,t ∼ F (θXn,t ) (6) θXn ∼ Conj(γ ) ∼ H (Xe:{n,·}∈Gt , µ) φn,Xe:{n,·}∈Gt (8) (7) Unlike the CHMM, whose transition matrix φn for HMM n is dependent on all other HMMs, φn in the GCHMM is dependent on only the HMMs that have edges in the graph connected to node n. Thus, φi,X· becomes φn,Xe:{n,·}∈Gt . We assume that n itself is also included in this set of HMMs on which n is dependent. There is also a difference in the prior distribution of φn . In the CHMM, the prior is the same for all rows of the transition matrix, whereas in the GCHMM the prior on φn , H , depends on the values of the states of the HMMs on which n is dependent at the previous time step. The graphical model for the GCHMM is given in fig- ure 2. Here, we show a GCHMM with 3 HMMs. Net- work structure Gt is depicted in the bubbles above each time step, also showing the dependency structure corresponding to Gt in the GCHMM graphical model. The structure for Gt−1 is not displayed, since it would be off the left side of the figure. This is a discrete-time multi-agent model, and thus it approximates its continuous-time multi-agent counter- part: a Markov jump process, also called a compound Poisson process. This approximation works well only when the time step size in the discrete-time model is smaller than the average rate of interaction events. In our setting, as in many settings in which these multi agent models may be used, this is not an issue. In the following, we describe an application of the GCHMM to fit susceptible-infectious-susceptible epi- demic dynamics. Here, we assume specific forms for distributions F and H . Much like in the CHMM, efficient inference may not always be possible in the GCHMM, but we show that efficient inference can eas- ily be done in our specific application. We expect that efficient inference in the GCHMM will be possible for many applications, since the incorporation of social networks in the GCHMM leads to sparsity in the con- Figure 1: CHMM graphical model on social network structure, and for which efficient inference can be performed based on the inter-chain “relations” of sufficient statistics. The CHMM generative model can easily be formulated in a Bayesian manner, which helps to avoid overfitting problems in real-world applications [Beal, 2003]: θXi ∼ Conj(γ ) φi,X· ∼ Dirichlet(α) (3) (4) where Conj refers to the distribution conjugate to F , above, and γ and α are shared hyperparameters. Here, θXi and φi,X· are drawn once for all times t. Xi is the set of all state values that HMM i can take on, while X· is the set of all state values that all HMMs can take on in the CHMM. This is the Bayesian formulation of the CHMM that we extrapolate in the next section in order to deal with situations wherein the relationship between HMMs is mediated by a dynamic social network. 3 GRAPH-COUPLED HIDDEN MARKOV MODELS Here, we introduce the graph-coupled hidden Markov model (GCHMM) to model how infection and influ- ence spread via the interactions of agents in a dynamic social network. Let Gt = (N , Et ) be a dynamic network, where each n ∈ N is a node in Gt representing an individual agent, and Et = {(ni , nj )} is a set of edges in Gt represent- ing interactions between agents ni and nj at time t. Graph Gt changes over time, where there is a discrete number of observations of the structure of the graph at times t ∈ {1 . . . T }. Changes in Gt over time represent changes in interactions between agents in the network over time. X1,t-1X2,t-1X1,tX2,tY1,t-1Y2,t-1Y1,tY2,tt-1tHMM 1HMM 2X1,t+1X2,t+1Y1,t+1Y2,t+1Time............t+1 lations, respectively. The differential equation model S = −β · S I + γ · I and I = β · S I − γ · I for SIS spec- ifies that the rate of change of infectious-population density is bilinear for both infectious-population den- sity and susceptible-population density. In this sys- tem, any two individuals from the infectious popu- lation are treated as the same, as are any two indi- viduals from the susceptible population, and therefore any two individuals from different populations have an equal chance of causing infection. The stochas- tic model S + I → 2I , rate = β (cid:48) · S · I and I → S, rate = γ (cid:48) · I specifies that infection happens at a bilinear rate for both the infectious-population density and the susceptible-population density. This model enables us to reason about the randomness in the SIS system when the population size is small and randomness cannot be ignored. The above models focus on the statistics of the spread of infection over a homogeneous population. How- ever, we are instead interested in predicting the spread of infection on an individual level, given relevant in- formation about each specific individual. Our goal is to explain symptom observations in a commu- nity with susceptible-infectious-susceptible dynamics at any given point in time. How likely is a person to be infectious at time t, given that his friends are reporting symptoms, reporting no symptoms, or not answering surveys, and given the infectious person’s own survey responses and his recent proximity to his friends? Which nodes and links are critical in spread- ing infection in the community? How can we control infection in this community? We use the GCHMM to address these questions, fol- lowing the generative model given in section 3 and the details (state space, H , F , and so on) specified here. Gt = (N , Et ) is a dynamic network, where each node n ∈ N represents a person in the network, and Et = {(ni , nj )} is a set of edges in Gt representing the fact that person ni and person nj have interacted or come into contact at time t. There are two pos- sible latent states for each person n at each time t, Xn,t ∈ {0, 1}, where 0 represents the susceptible state and 1 the infectious state. There are six possible symp- toms that can be displayed by a person at any given time, Yn,t , which are runny nose, coughing, fever, feel- ing stressed, sadness, and diarrhea, and each symptom Yn,t,i ∈ {0, 1} represents the presence or absence of symptom i. Our generative model is therefore as follows: Xn,t ∼ Bernoulli(φn,Xe:{n,·}∈Gt ,t−1 ) Yn,t,i ∼ Bernoullii (θXn,t ) (9) (10) Figure 2: GCHMM graphical model nections between latent variables, since these networks are typically sparse, and the incorporation of structure resulting from network-specific prior knowledge in H can also often be leveraged. For example, as in the epidemics model, H can become a simple function of a few parameters and sufficient statistics of connected states. 4 GCHMMS FOR MODELING INFECTION DYNAMICS In this section, we show that the GCHMM can be used as a discrete-time multi-agent epidemic model, where the spread of infection is modeled on an individual level as opposed to the standard population-level models commonly used in epidemiology. In section 6, we show that the GCHMM can be applied to real-world data based on individual proximity and symptom reporting. In particular, the GCHMM that we apply to epidemics can be seen as an individual-level version of the clas- sic susceptible-infectious-susceptible (SIS) epidemiol- ogy model. The SIS model describes infection dynam- ics in which the infection does not confer long-lasting immunity, and so an individual becomes susceptible again once recovered (e.g., the common cold). Using the GCHMM to model SIS dynamics identifies paths of infection based on individual-level interac- tions that are captured in our data.The classical differ- ential equation and stochastic models of SIS dynamics work at the population level, and their variables are density and size of susceptible and infectious popu- X1,t-1X2,t-1X3,t-1X1,tX2,tX3,tY1,t-1Y2,t-1Y3,t-1Y1,tY2,tY3,tt-1tHMM 1HMM 2HMM 3X1,t+1X2,t+1X3,t+1Y1,t+1Y2,t+1Y3,t+1Time123..................t+1123123 θXn ∼ Beta(h) (11) This is identical to the generative model from section 3 (the Bernoulli is the same as Categorical for 2 states), with F specified as a multivariate Bernoulli distribu- tion. Here, h are given hyperparameters. The gener- is a little more subtle, ative process for φn,Xe:{n,·}∈Gt as it is defined using the interaction structure in the network, detailed below.. (12) µ = In keeping with the SIS model, we assume that there are certain transmission rates for the infection of one person by another, and likewise a recovery rate for an infected individual: α ∼ Beta(a, b) β ∼ Beta(a(cid:48) , b(cid:48) ) γ ∼ Beta(a(cid:48)(cid:48) , b(cid:48)(cid:48) ) γ is the probability that a previously-infectious in- dividual recovers and so again becomes susceptible (p(Xn,t+1 = 0Xn,t = 1)), β represents the proba- bility that an infectious person infects a previously- susceptible person (p(Xni ,t+1 = 1Xni ,t = 0, Xnj ,t = 1, {ni , nj } ∈ Et+1 )), and α represents the probabil- ity that an infectious person from outside the network infects a previously-susceptible person within the net- work. Each of these infection probabilities is assumed to be independent. It is also assumed that a person cannot be infected by more than one infectious per- sons at the same time. Here, {a, b, a(cid:48) , b(cid:48) , a(cid:48)(cid:48) , b(cid:48)(cid:48)} are given hyperparameters. Therefore, we can now compute transition matrix φn,Xe:{n,·}∈Gt (and thus specify H from section 3) in terms of α, β , and γ : p(Xn,t+1 = 0Xn,t = 1) = γ P (Xn,t+1 = 1Xn,t = 0, Xe:{n,·}∈Gt ) (14) = 1 − P (Xn,t+1 = 0Xn,t = 0, Xe:{n,·}∈Gt ) (cid:80) = 1 − (1 − α)(1 − β ) Xn(cid:48) ,t e:{n,·}∈Gt (13) α + β · (cid:80)Xe:{n,·}∈Gt Xe:{n,·}∈Gt ,t ), since the probabil- 1 ity that more than one source contributed to infection is also small. If this assumption is correct, then the probability of seeing an entire state sequence/matrix X is therefore as follows: (cid:89) P (X, α, β , γ ) (cid:89) = P (α)P (β )P (γ ) P (Xn,1 ) n (cid:48) ∈N ,t}, α, β , γ ) P (Xn,t+1 {Xn (cid:89) t,n (cid:89) = P (α)P (β )P (γ ) n γ 1Xn,t=1 ·1Xn,t+1=0 · (1 − γ )1Xn,t=1 ·1Xn,t+1=1 · Xe:{n,·}∈Gt (cid:88) t,n Xe:{n,·}∈Gt ,t )1Xn,t=0 ·1Xn,t+1=1 · (α + β · Xe:{n,·}∈Gt (cid:88) 1 Xe:{n,·}∈Gt ,t )1Xn,t=0 ·1Xn,t+1=0 (1 − α − β · 1 P (Xn,1 ) (15) It is assumed that all people start off in the susceptible state, and that 1• in the above equation is the indicator function. In general, we can often identify M types of events in agent-based models, sometimes by taking small enough time intervals in time-discretization to make first-order approximation sufficient, and count the dif- ferent ways that events of type m ∈ {1, . . . , M } could change an agent’s state from x(cid:48) at time t to state x (cid:54)= x(cid:48) at time t + 1, gm (X•,t+1 = x, {Xn,t : n, t}). The state transition matrix can then be defined as P (Xn,t+1 = xXn,t (cid:54)= x, Xe:{n,•}∈Gt ) ≈ M(cid:88) µm · gm (Xn,t+1 = x, Xn,t , Xe:{n,•}∈Gt ), m=1 where µm is the success rate of event type m. (16) Thus our H from equation 8 is now a simple func- tion of parameters µ and sufficient statistics of con- nected states, g(X ), given by the summation term in the above equation. Intuitively, the probability of a susceptible person becoming infected is 1 minus the probability that no one, including someone from out- side the network, or any of the people within the network with whom the susceptible person is known to have interacted, infected that individual. When the probability of infection is very small, it is ap- proximately the sum of the probabilities from differ- ent sources (P (Xn,t+1 = 1Xn,t = 0, Xe:{n,·}∈Gt ) ≈ This formulation of the GCHMM enables us to fit a wide range of agent-based models to “big data” sets of networked people, by specifying the right ways of counting events [Castellano et al., 2009]. For exam- ple, in the Szna jd model of opinion dynamics [Szna jd- Weron, 2005], any pair of agents with the same opinion will have a small chance µ of convincing one of their (cid:1), and the neighbors is then g(X ) = (cid:0)(cid:80) neighbors to change to their opinion. The number of ways that an individual can be convinced by a pair of (n(cid:48) ,n)∈Gt n(cid:48) (cid:54)=Xn 1X chance that an agent is convinced is µ · g(X ). Szna jd’s 2 model captures the intuition that we might not pay attention to a single person looking up, but we would look up if a group of people look up. 5 INFERENCE In this section, we present an efficient inference algo- rithm for our GCHMM in order to describe and pre- dict the spread of infection. We start by describing inference in the most general, worst case for GCH- MMs, and progress from there to much more efficient inference for the epidemics model. The worst case in- ference algorithm for GCHMMs will be the same as for CHMMs (the case where the graph is complete). A Gibbs sampling algorithm for a particular CHMM with two chains is given in [Rezek et al., 2000], which we extend here to an unconstrained number of chains. The two sampling steps relevant to the extension to multiple chains become: (cid:80) p(Xn,t+1 = j, Y γ , φ) Xn,t+1 ∼ Categorical([ k p(Xn,t+1 = k , Y γ , φ) T(cid:88) φn,i ∼ Dirichlet([αj + 1(Xn,τ +1 = j ∧ X•,τ = i)]) τ =1 ]) Here j and k are states of n, and i is the transition matrix row number corresponding to a combination of states for all nodes. We can see that this sampling procedure is not very efficient, particularly for a rea- sonably large number of chains. Fortunately, in practice most social networks are sparse - far from complete. The number of parame- ters needed to be inferred will decrease dramatically for sparse networks (from O(N N ) to O(N nmax ) where nmax is the maximum number of connections for node n). The parameters of the transition matrix can now be sampled conditioned on the network structure: φn,i ∼ Dirichlet([αj + T(cid:88) 1(Xn,τ +1 = j ∧ Xe:{n,·}∈Gτ +1 ,τ = i)]) τ =1 (17) Here i now corresponds to a combination of the states of nodes connected to n only. While significantly bet- ter than the full CHMM, this may still be intractable for large N or T . However, the interaction structure that we are interested in is also not typically governed by unrestricted transition matrices, φ. There is struc- ture to interactions or behavior that we can leverage to drastically increase efficiency. One common exam- ple is that all agents may be sub ject to the same φ. Another is that interactions themselves have a struc- ture which can be captured by an H (µ, g(X )), where H is now a function parameterized by a reasonably small set of parameters µ and sufficient statistics of the current state space g(X ). This allows us to sam- ple p(µg(X )), and then compute φ, unlike in the algo- rithms above. This form of H applies to many multi- agent network models including the emergence of col- laboration, the spread of rumors and the formation of culture. It similarly applies to our epidemics model, as described in section 4, where where g(X ) can be efficiently computed at each node, at each time step. We now describe the resulting inference method for the epidemics model, and then briefly discuss applying the same inference scheme to some more general, g(X ). The epidemics inference algorithm learns the param- eters of infection dynamics, including the rate of in- fection and rate of recovery. It then estimates the likelihood that an individual becomes infectious from the contact with other students based on the reported symptoms of others, and even when the individual’s own symptom report is not available. Finally, the al- gorithm enables us to make useful predictions about the spread of infections within the community in gen- eral. We employ a Gibbs sampler to iteratively sample the infectious/susceptible latent state sequences, to sam- ple infection and recovery events conditioned on these state sequences, and to sample model parameters. The Gibbs sampler for the GCHMM for epidemics is given in detail below. The Gibbs sampler takes the following as its input: G = (N , E ): a dynamic network where nodes n ∈ N represent a person in the network, and Et = {(ni , nj )} is a set of edges in Gt representing that person ni and person nj have interacted or come into contact at time t. Y : an observation matrix of symptoms indexed by time and node. The Gibbs sampler gives the following output: {X, α, β , γ , θ}s : samples s. This includes several pa- rameters: α, the base rate of infection; β , the rate of infection by each infectious neighbor in Gt ; and γ , the rate of recovery. It includes the emission matrix θ , which expresses the probability of seeing each of the six symptoms given the infectious/susceptible la- tent state. It also includes the state matrix X of the epidemics GCHMM, which shows sequences of states 0 (susceptible) and 1 (infectious) for each individual over time. We randomly initialize the model parameters and set the state matrix so that every individual in the net- work is in the susceptible state. The Gibbs sampler (18) then iterates through sampling the latent states: (cid:33) (cid:32) Xn,t+1 {X, Y }\Xn,t+1 ; α, β , γ ∼ (cid:80) P (Xn,t+1 = 1) Bernoulli x=0,1 P (Xn,t+1 = x) P (Xn,t+1 = 1) = P (X α, β , γ )P (Y X ) where P (X α, β , γ ), is the same as in equation 15 mi- nus the priors on α, β , and γ . P (Y X ) can be com- (cid:81) puted in a straightforward manner from the product of entries in the emissions matrix, θ , where P (Y X ) = n,t,i P (Yi,n,t Xn,t ). After sampling the latent states X , we sample infection events. Due to the interaction structure, and to ease sampling, we introduce the auxiliary variable Rn,t to track the source of an infection (inside or outside the network) if an infection event occurs for person n at time t + 1 (i.e., Xn,t = 0 and Xn,t+1 = 1):  (19)  α + β (cid:80) α, β , . . . , β 1(n(cid:48) ,n)∈Et∩Xn(cid:48) ,t=1 n(cid:48) Rn,t ∼ Categorical α ∼ Beta(a + Here Rn,t takes the value 1 if the infection event orig- inated outside the network, and Rn,t > 1 if transmis- sion came from someone within the network. Given the state sequences X and infection events R, we can sample the remaining parameters from their posteri- ors: (cid:88) (cid:88) 1 − (cid:88) 1{Rn,t=1} , n,t (cid:88) 1{Rn,t=1} ), b + n,t n,t:Xn,t=0 β ∼ Beta(a(cid:48) + 1(n(cid:48) ,n)∈Et∩Xn(cid:48) ,t=1 − (cid:88) (cid:88) 1{Rn,t>1} , n,t (cid:88) n,t:Xn,t=0;n(cid:48) n,t γ ∼ Beta(a(cid:48)(cid:48) + 1 − (cid:88) (cid:88) 1{Xn,t+1=0} , n,t:Xn,t=1 1{Xn,t+1=0} ). n,t:Xn,t=1 n,t:Xn,t=1 1{Rn,t>1} ), b(cid:48)(cid:48) + b(cid:48) + (20) (21) (22) In the more general M state case, we can sample Xn,t+1 from its posterior categorical distribution sim- ilar to equation 18, sample events Rn,t ∈ {1, . . . , M } (reflecting which type of event caused the state change of Xn,t , c.f., equation 16) similar to equation 19, and (23) sample the success rates of different types of events similar to equation 20. (cid:18) (cid:19) Xn,t+1 {X, Y }\Xn,t+1 ; µ (cid:80) (cid:19) (cid:18) µ1 g1 , . . . , µM gM ∼ Categorial P (Xn,t+1 ) (cid:80) x P (Xn,t+1 = x) (cid:88) Rn,t ∼ Categorial m µm gm µm ∼ Beta(am + (cid:88) 1Rn,t=m , n,t n,t gm − 1Rn,t=m ) bm + (24) (25) , , 6 EXPERIMENTAL RESULTS In this section we describe the performance of the epi- demics GCHMM in predicting missing data in multiple synthetic time series, comparing to a Support Vector Machine (SVM) and standard SIS model. We also fit our epidemics model to the hourly proximity records and self-reported symptoms in a real world Social Evo- lution data set. 6.1 CONTAGION IN THE SOCIAL EVOLUTION EXPERIMENT To demonstrate the potential of GCHMMs and our epidemics model, we use it on the data collected in the Social Evolution experiment [Dong et al., 2011], part of which tracked common cold symptoms in a student residence hall from January 2009 to April 2009. This study monitored more than 80% of the residents of the hall through their mobile phones from October 2008 to May 2009, taking periodic surveys which included health-related issues and interactions, and tracked their locations. In particular students an- swered flu surveys, about the following symptoms: (1) runny nose, nasal congestion, and sneezing; (2) nau- sea, vomiting, and diarrhea; (3) frequent stress; (4) sadness and depression; and (5) fever. Altogether, 65 residents out of 84 answered the flu surveys. Because of the symptom reports and proximity infor- mation, the Social Evolution data is a good test bed for fitting infection models to real-world data, and for inferring how friends infect one another: For almost all symptoms, a student with a symptom had 3-10 times higher odds of having friends with the same symptom, confirming that symptoms are probabilistically depen- dent on their friendship network. The durations of symptoms averaged two days, and fit an exponential distribution well, agreeing with the discussed epidemic models. The base probability of a sub ject reporting a symptom is approximately 0.01, and each individ- ual had a 0.0060.035 increased chance of reporting a symptom for each additional friend with the same symptom, in line with the assumption that the rate of contagion is proportional to the likelihood of contact with an infected individual. 6.2 CALIBRATING PERFORMANCE We took several steps to calibrate the performances of our epidemics GCHMM and a support vector classifier on synthetic data. First, we synthesized 200 time series – each 128 days long – from the Bluetooth proximity pattern in the Social Evolution data and different pa- rameterizations. Then, we randomly removed the in- fectious/susceptible data from 10% of the population, added noise to each time series, and then inferred the held-out data with each method, for each parameteri- zation. The different parameterizations were (1) α = 0.01, β = 0.02, and γ = 0.3, with observation error 0.01; (2) α = 0.01, β = 0.02, and γ = 0.3, with observation error 0.001; and (3) α = 0.005, β = 0.045, and γ = 0.3, with observation error 0.01. Comparing performances between (1) and (2) enables us to see the effect of ob- servation error on algorithm performance. Comparing performances between (1) and (3) enables us to see the effect of the network on algorithm performance. Comparing performances between methods enables us to see the difference between our model-based learning and the SVM or SIS model. We ran Gibbs samplers for 10,000 iterations, including 1000 for burn-in. We trained the SVM on a 1000-day time series synthesized using the correct parameteriza- tion, and used the number of infectious contacts yes- terday, today, and tomorrow as features. We assigned different weights to the “infected” class and the “sus- ceptible” class to balance the true and false prediction rates. All methods can easily identify 20% of infectious cases in the missing data with little error; however, the our model-based method consistently performs better than SIS and SVM. Less noise in symptoms observations and in the contact networks of individuals significantly improves the performance of inferring missing data, as shown in Figure 3. An ROC curve shows how differ- ent algorithms compare in terms of inferring infectious cases in the held out 10% of the data. The SVM performs poorly – especially at identify- ing isolated infectious cases – because it assumes that cases are i.i.d and because properly incorporating the temporal structure of epidemic dynamics into the fea- tures is not easy. The SVM also assumes that we have enough training data. This assumption often cannot be satisfied for the kinds of problems we are inter- ested in. Lastly, we also compare to the traditional Figure 3: Less observation error (obs.err.=0.001) and better knowledge about the network (β = 0.045) result in a better trade-off between true positive rate (TPR) and false positive rate (FPR). Lack of knowledge about the network and assuming a compete graph structure result in poor trade-off between TPR and FPR. The support vector classifier has a worse trade-off between TPR and FPR than the epidemics GCHMM does. SIS methods (both pde and stochastic). They do not predict well because they treat everyone in the pop- ulation the same, regardless of individual interaction network information. Observation noise makes inferring the individual states difficult, since it increases uncertainty in the parame- ters of the system. Knowledge of the dynamic contact network also affects the quality of parameter estima- tion and state inference. The more we know about who contacted whom, the more targeted we can be in locating the infectious cases. 6.3 INFERRING COLD FROM SYMPTOMS AND PROXIMITY In this section, we report the results of our epidemics model on the Social Evoluation data. In order to infer infections we extracted an hour-by-hour prox- imity snapshot over the 107 days that we monitored symptoms, and interpolated hourly symptom reports from the daily symptom reports. We assumed that the symptoms are probabilistically independent given the common cold (infectious) state. We ran the Gibbs sampler for 10,000 iterations, with 1000 burn-in itera- tions. We do not have the clinical certainty of common cold 0.00.20.40.60.81.00.00.20.40.60.81.0False positive rateTrue positive ratestochastic SISPDE SISGraph−CHMM(α=0.01, β=0.02, γ=0.3, obs.err.=0.01)Graph−CHMM(α=0.01, β=0.02, γ=0.3, obs.err.=0.001)Graph−CHMM(α=0.005, β=0.045, γ=0.3, obs.err.=0.01)SVM(α=0.01, β=0.02, γ=0.3, obs.err.=0.01) diagnoses . However, the statistics that we discuss be- low give solid evidence that the epidemics model cap- tures the structure of a infection process accompanying the symptom report. Figure 4 shows the (marginal) likelihood of the daily common-cold states of individuals. Rows in this heat map are indexed by sub jects, arranged so that friends go together, and then placed next to a dendrogram that organizes friends hierarchically into groups. Dif- ferent colors on the leaves of the dendrogram repre- sent different living sectors in the student residence hall. Columns in this heat map are indexed by date in 2009. Brightness of a heat-map entry indicates the likelihood of infectiousness - the brighter a cell, the more likely it is that the corresponding sub ject is in- fectious on the corresponding day. Sizes of black dots represent the number of reported symptoms. When a black dot doesn’t exist on a table entry, the corre- sponding person didn’t answer the survey that day. This heat map shows clusters of common-cold infec- tions. When larger clusters of interpersonal proxim- ities occurred , symptom clusters lasted longer and involved more people. The heat map also tells us that sub jects often submitted flu-symptom surveys daily when they were healthy, but would forget to submit surveys when in the infectious state. The Gibbs sam- pler nonetheless uses the data to determines that the individual was infectious for these days. Similarly, a sub ject sometimes reported isolated symptoms. The Gibbs sampler is able to conclude the he was most likely healthy, because the duration of the symptom reports didn’t agree with the typical duration of a common cold, and because his symptom report was isolated in his contact network. Inferred Infectious states normally last four days to two weeks. A student typically caught a cold 2-3 times during this time span. The bi-weekly searches of the keyword “flu” from January 2009 to April 2009 in Boston – as reported by Google Trends – correlated with these findings. 7 CONCLUSIONS We have presented the GCHMM for modeling discrete- time multi-agent dynamics when the agents are con- nected through a social network. We showed that the GCHMM can be used as an individual-level SIS model to successfully predict the spread of infection through- out a social network. In the future, it would be inter- esting to use the GCHMM to learn graph dynamics, or to predict missing links. It would also be interesting to try to use the GCHMM in applications with a more complex transition matrix structure. Figure 4: Our epidemics GCHMM can infer common cold state, and captures infection data from symp- tom self-reports and the proximity network. The size of black dots represents the number of symptoms re- ported, ranging from zero symptoms to all, and no black dot means no self-report. The study of infection in small populations has im- portant implications both for refining epidemic models and for advising individuals about their health. The spread of infection in this context is poorly understood because of the difficulty in closely tracking infection throughout a complete community. This paper show- cases the spread of an infection centered on a student dormitory, with data based on daily symptom surveys over a period of four months and on proximity track- ing through mobile phones. It also demonstrates that fitting a discrete-time multi-agent model of infection to real-world symptom self-reports and proximity ob- servations gives us useful insights into infection paths and control. Acknowledgements Research was sponsored by the Army Research Laboratory under Cooperative Agreement Number W911NF-09-2-0053, and by AFOSR under Award Number FA9550-10-1-0122. Views and conclusions in this document are those of the authors and should not be interpreted as representing the official policies, ei- ther expressed or implied, of the Army Research Labo- ratory or the U.S. Government. The U.S. Government is authorized to reproduce and distribute reprints for Government purposes notwithstanding any copyright notation. Katherine Heller was supported on an NSF postdoctoral fellowship. ●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●●01/11/200901/18/200901/25/200902/01/200902/08/200902/15/200902/22/200903/01/200903/08/200903/15/200903/22/200903/29/200904/05/200904/12/200904/19/2009day in 2009subjects Marcel Salath´e, Maria Kazandjiev, Jung Woo Lee, Philip Levis, Marcus W. Feldman, and James H. Jones. A high- resolution human contact network for infectious disease transmission. In Proceedings of the National Academy of Science of the United States of America, volume 107, pages 22020–22025, 2010. Luc Steels. A self-organizing spatial vocabulary. Artificial Life, 2(3):319–332, 1995. URL http://www.isrl.uiuc. edu/~amag/langev/paper/steels96aSelf.html. Juliette Stehl´e, Nicolas Voirin, Alain Barrat, Ciro Cattuto, Vittoria Colizza, Lorenzo Isella, Corinne R´egis, Jean- Fran¸cois Pinton, Nagham Khanafer, Wouter Van den Broeck, and Philippe Vanhems. Simulation of an seir infectious disease model on the dynamic contact network of conference attendees. BMC Medicine, 9(1):87, 2011. K. Szna jd-Weron. Szna jd model and its applications. Acta Physica Polonica B, 36(8):2537–2547, 2005. References Robert Axelrod. The dissemination of culture — a model with local convergence and global polarization. Journal of Conflict Resolution, 2(203-226), 41. Matthew J. Beal. Variational Algorithms for Approximate Bayesian Inference. PhD thesis, Gatsby Computational Neuroscience Unit, University College London, 2003. Matthew Brand, Nuria Oliver, and Alex Pentland. Coupled hidden markov models for complex action recognition. In CVPR, pages 994–999. IEEE Computer Society, 1997. Claudio Castellano, Santo Fortunato, and Vittorio Loreto. Statistical physics of social dynamics. Reviews of Modern Physics, 81:591–646, 2009. Wen Dong, Bruno Lepri, and Alex Pentland. Modeling the co-evolution of behaviors and social relationships using mobile phone data. In Qionghai Dai, Ramesh Jain, Xi- angyang Ji, and Matthias Kranz, editors, MUM, pages 134–143. ACM, 2011. ISBN 978-1-4503-1096-3. S. Eubank, H. Guclu, V. Kumar, M. Marathe, A. Srini- vasan, Z. Toroczkai, and N. Wang. Modelling disease outbreaks in realistic urban social networks. Nature, 429: 180–4, 2004. Zoubin Ghahramani and Michael I. Jordan. Factorial hid- den markov models. Machine Learning, 29(2-3):245–273, 1997. Anna Goldenberg, Alice X. Zheng, Stephen E. Fienberg, and Edoardo M. Airoldi. A survey of statistical network models. Found. Trends Mach. Learn., 2:129–233, Febru- ary 2010. ISSN 1935-8237. Richard A. Holley and Thomas M. Liggett. Ergodic the- orems for weakly interacting infinite systems and the voter model. Annals of Probability, 3(4):643–663, 1975. L. Hufnagel, D. Brockmann, and T. Geisel. Forecast and control of epidemics in a globalized world. In Proc Natl Acad Sci USA, volume 101, pages 15124–9, 2004. Michael I. Jordan, Zoubin Ghahramani, and Lawrence K. Saul. Hidden markov decision trees. In Michael Mozer, Michael I. Jordan, and Thomas Petsche, editors, NIPS, pages 501–507. MIT Press, 1996. W. Kermack and A McKendrick. A contribution to the mathematical theory of epidemics. Proceedings of the Royal Society of London. Series A, Containing Papers of a Mathematical and Physical Character, 115(772):700– 721, August 1927. Wei Pan, Wen Dong, Manuel Cebrian, Taemie Kim, James H. Fowler, and Alex Pentland. Modeling dynam- ical influence in human interaction: Using data to make better inferences about influence within social systems. Signal Processing Magazine, IEEE, 29(2):77 –86, march 2012. ISSN 1053-5888. doi: 10.1109/MSP.2011.942737. I. Rezek, P. Sykacek, and S. J. Roberts. Learning interac- tion dynamics with coupled hidden Markov models. Sci- ence, Measurement and Technology, IEE Proceedings-, 147(6):345–350, 2000. URL http://ieeexplore.ieee. org/xpls/abs_all.jsp?arnumber=899989.
1910.12711
1
1910
2019-10-28T14:31:47
A framework for second order eigenvector centralities and clustering coefficients
[ "cs.SI", "math.NA", "math.NA", "physics.data-an" ]
We propose and analyse a general tensor-based framework for incorporating second order features into network measures. This approach allows us to combine traditional pairwise links with information that records whether triples of nodes are involved in wedges or triangles. Our treatment covers classical spectral methods and recently proposed cases from the literature, but we also identify many interesting extensions. In particular, we define a mutually-reinforcing (spectral) version of the classical clustering coefficient. The underlying object of study is a constrained nonlinear eigenvalue problem associated with a cubic tensor. Using recent results from nonlinear Perron--Frobenius theory, we establish existence and uniqueness under appropriate conditions, and show that the new spectral measures can be computed efficiently with a nonlinear power method. To illustrate the added value of the new formulation, we analyse the measures on a class of synthetic networks. We also give computational results on centrality and link prediction for real-world networks.
cs.SI
cs
A framework for second order eigenvector centralities and clustering coefficients Francesca Arrigo∗ Desmond J. Higham† Francesco Tudisco‡ Abstract We propose and analyse a general tensor-based framework for incorporating second order features into network measures. This approach allows us to combine traditional pairwise links with information that records whether triples of nodes are involved in wedges or triangles. Our treatment covers classical spectral methods and recently proposed cases from the literature, but we also identify many interesting extensions. In particular, we define a mutually-reinforcing (spectral) version of the classical clustering coefficient. The underlying object of study is a constrained nonlinear eigenvalue problem associated with a cubic tensor. Using recent results from nonlinear Perron -- Frobenius theory, we establish existence and uniqueness un- der appropriate conditions, and show that the new spectral measures can be computed efficiently with a nonlinear power method. To illustrate the added value of the new formulation, we analyse the measures on a class of synthetic networks. We also give computational results on centrality and link prediction for real-world networks. AMS subject classifications. 15A69, 05C65, 91D30, 05C81, 05C82, 37C25 Keywords. Clustering coefficient, Eigenvector centrality, Higher order network analysis, Tensor, Hyper- graph, Perron-Frobenius theory, Link prediction. 1 Introduction and motivation The classical paradigm in network science is to analyse a complex system by focusing on pairwise interactions; that is, by studying lists of nodes and edges. However, it is now apparent that many important features arise through larger groups of nodes acting together [7]. For example, the triadic closure principle from the social sciences suggests that connected node triples, or triangles, are important building blocks [8, 14, 17, 25]. Of course, there is a sense in which many algorithms in network science indirectly go beyond pairwise interactions by considering traversals around the network. However, recent work [4, 5, 14, 28] has shown that there is benefit in directly taking account of higher-order neighbourhoods when designing algorithms and models. From the point of view of algebraic topology, higher-order relations coincide with different homology classes and the idea of exploring connections of higher-order in networks is analogous to the idea of forming a filtered cell complex in topological data analysis [13]. In a similar manner to point clouds, complex networks modeling various type of interactions (such as social, biological, communication or food networks) have an intrinsic higher-order organization [7]. So, efficiently accounting for higher-order topology can allow more robust and effective quantification of nodal importance in various senses [9, 43]. Our aim here is to develop and analyse a general framework for incorporating second order features; see Definition 3.1. This takes the form of a constrained nonlinear eigenvalue problem associated with a nonlinear mapping defined in terms of a square matrix and a cubic tensor. For specific parameter choices we recover both standard and recently proposed network measures as special cases. We also construct many interesting new alternatives. In this eigenproblem-based setting, the network measures naturally incorporate mutual reinforcement; important objects are those that interact with many other important objects. The classic PageRank algorithm [24] is perhaps the best known example of such a measure. Within this setting, in Definition 3.2 we define for the first time a mutually reinforcing version of the classical Watts-Strogatz Clustering ∗Department of Mathematics and Statistics, University of Strathclyde, GX11H Glasgow (UK) †School of Mathematics, University of Edinburgh, EH93FD Edinburgh (UK) ‡School of Mathematics, GSSI Gran Sasso Science Institute, 67100 L'Aquila (Italy) 1 2 Background and related work 2 Coefficient [47]; here we give extra weight to nodes that form triangles with nodes that are them- selves involved in important triangles. We show that our general framework can be studied using recently developed tools from nonlinear Perron -- Frobenius theory. As well as deriving existence and uniqueness results we show that these measures are computable via a nonlinear extension of the power method; see Theorem 4.1. The manuscript is organized as follows. In section 2 we summarize relevant existing work on spectral measures in network science. Section 3 sets out a general framework for combining first and second order information through a tensor-based nonlinear eigenvalue problem. We also give several specific examples in order to show how standard measures can be generalized by including second order terms. In section 4 we study theoretical and practical issues. Section 5 illustrates the effect of using second order information through a theoretical analysis on a specific class of networks. In section 6 we test the new framework on real large scale networks in the context of centrality assignment and link prediction. Conclusions are provided in section 7. 2 Background and related work 2.1 Notation A network or graph G = (V, E) is defined as a pair of sets: nodes V = {1, 2, . . . , n} and edges E ⊆ V × V among them. We assume the graph to be undirected, so that for all (i, j) ∈ E it also holds that (j, i) ∈ E, unweighted, so that all connections in the network have the same "strength", and connected, so that it is possible to reach any node in the graph from any other node by following edges. We further assume for simplicity that the graph does not contain self-loops, i.e., edges that point from a node to itself. A graph may be represented via its adjacency matrix, A = (Aij) ∈ Rn×n, where Aij = 1 if (i, j) ∈ E and Aij = 0 otherwise. Under our assumptions, this matrix will be symmetric, binary and irreducible. We write GA to denote the graph associated with the adjacency matrix A. We let 1 ∈ Rn denote the vector with all components equal to 1 and 1i ∈ Rn denote the ith vector of the standard basis of Rn. 2.2 Spectral centrality measures A centrality measure quantifies the importance of each node by assigning to it a nonnegative value. This assignment must be invariant under graph isomorphism, meaning that relabeling the nodes does not affect the values they are assigned. We focus here on degree centrality and a family of centrality measures that can be described via an eigenproblem involving the adjacency matrix. This latter family includes as special cases eigenvector centrality and PageRank. The degree centrality of a node is found by simply counting the number of neighbours that it possesses; so node i is assigned the value di, where d = A1. Degree centrality treats all connections equally; it does not take account of the importance of those neighbours. By contrast eigenvector centrality is based on a recursive relationship where node i is assigned a value xi ≥ 0 such that x is proportional to Ax. We will describe this type of measure as mutually reinforcing, because it gives extra credit to nodes that have more important neighbours. Under our assumption that A is irreducible, the eigenvector centrality measure x corresponds to the Perron -- Frobenius eigenvector of A. We note that this measure was popularized in the 1970s by researchers in the social sciences, [42], but can be traced back to algorithms used in the 19th century for ranking chess players, [44]. For our purposes, it is useful to consider a general class of eigenvector based measures of the form (1) where M ∈ Rn×n is defined in terms of the adjacency matrix A. For example, we may use the adjacency matrix itself, M = A, or the PageRank matrix x ≥ 0 such that M x = λ x, (2) with c ∈ (0, 1), v ≥ 0 such that (cid:107)v(cid:107)1 = 1 and D the diagonal matrix such that Dii = di. With this second choice, the eigenvector solution of (1) is the PageRank vector [24]. M = cAD−1 + (1 − c)v1T , 3 General eigenvector model 3 2.3 Watts-Strogatz clustering coefficient The Watts-Strogatz clustering coefficient was used in [47] to quantify an aspect of transitivity for each node. To define this coefficient, we use (cid:52)(i) = (A3)ii/2 to denote the number of unoriented triangles involving node i. Note that node i is involved in exactly di(di − 1)/2 wedges centred at i, that is, paths of the form hij where h, i, j are distinct. Hence node i can be involved in at most di(di − 1)/2 triangles. The local Watts -- Strogatz clustering coefficient of node i is defined as the fraction of wedges that are closed into triangles: (cid:40) 2(cid:52)(i) di(di−1) 0 ci = if di ≥ 2 otherwise. (3) It is easy to see that ci ∈ [0, 1] with ci = 0 if node i does not participate in any triangle and ci = 1 if node i has not left any wedges unclosed. Related to this measure of transitivity for nodes there are two network-wide versions; the average clustering coefficient n(cid:88) i=1 C = 1 n ci = 2 n (cid:88) i:di≥2 (cid:52)(i) di(di − 1) and the global clustering coefficient or graph transitivity [36] (cid:98)C = (cid:80) 6K3 i di(di − 1) , where K3 is the number of unoriented triangles in the network and the multiplicative factor of 6 comes from the fact that each triangle closes six wedges, i.e., the six ordered pairs of edges in the triangle. This latter measure has been observed to typically take values between 0.1 and 0.5 for real world networks; see [22]. The global and average clustering coefficients have been found to capture meaningful features and have found several applications [38, 40]; however, they may behave rather differently for certain classes of networks [16]. In this work we focus on the local measure defined in (3). Beyond social network analysis, this index has found application, for example, in machine learning pipelines, where nodes features are employed to detect outliers [30] or to inform role discovery [1, 26], in epidemiology, where efficient vaccination strategies are needed [15], and in psychology [3], where it is desirable to identify at-risk individuals. We see from (3) that the Watts -- Strogatz clustering coefficient may be viewed as a second order equivalent of degree centrality in the sense that it is not mutually reinforcing -- a node is not given any extra credit for forming triangles with well-clustered nodes. In Definition 3.2 below we show how a mutually reinforcing clustering coefficient can be defined. 3 General eigenvector model To incorporate second order information, given a tensor T ∈ Rn×n×n and a parameter p ∈ R we define the operator T p : Rn → Rn that maps the vector x ∈ Rn to the vector entrywise defined as n(cid:88) j,k=1 T p(x)i = T ijk µp(xj, xk), (4) where µp(a, b) is the power (or binomial) mean (cid:18)ap + bp (cid:19)1/p . 2 µp(a, b) = Recall that the following well known properties hold for µ: geometric mean; max{a,b} is the maximum function; whereas limp→−∞ µp = min{a,b} is the minimum. ii) µ−1(a, b) = 2(x−1 + y−1)−1 is the harmonic mean; iii) limp→+∞ µp = We may then define the following nonlinear network operator, and associated spectral centrality measure, which combines first and second order interactions. i) limp→0 µp(a, b) = (cid:112)ab is the 3 General eigenvector model 4 Definition 3.1. Let α ∈ R be such that 0 ≤ α ≤ 1, let p ∈ R and let M ∈ Rn×n and T ∈ Rn×n×n be an entrywise nonnegative square matrix and an entrywise nonnegative cubic tensor associated with the network, respectively. Define M : Rn → Rn as (5) Then the corresponding first and second order eigenvector centrality of node i is given by xi ≥ 0, where x solves the constrained nonlinear eigenvalue problem M(x) = αM x + (1 − α)T p(x). x ≥ 0 such that M(x) = λ x. (6) If we set α = 1 in (6) then only first order interactions are considered, and we return to the classical eigenvector centrality measures discussed in section 2. Similarly, with α = 0 only second order interactions are relevant. In the next subsection we discuss specific choices for M and T . We also note that in order for the measure in Definition 3.1 to be well defined, there must exist a unique solution to the problem (6). We consider this issue in section 4. 3.1 Specifying M and T In Definition 3.1, the matrix M should encode information about the first order (edge) interactions, with the tensor T representing the triadic relationships among node triples, that is, second order interactions. Useful choices of M are therefore the adjacency matrix or the PageRank matrix (2). Another viable choice, which we will use in some of the numerical experiments, is a rescaled version of the adjacency matrix M = AD−1, which we will refer to as the random walk matrix. We now consider some choices for the tensor T to represent second order interactions. Binary triangle tensor. Perhaps the simplest choice of second order tensor is (T B)ijk = 1 if i, j, k form a triangle 0 otherwise. (7) As discussed, for example, in [45], we can build T B with worst case computational complexity of O(n3) or O(m3/2), where n is the number of nodes in the network and m is the number of edges. Moreover, in [6] the authors construct the triangles tensor of four large real-world networks (Email EUAll, soc Epinions1, wiki Talk, twitter combined) and observe that the number of non- zero entries in T B is O(6m). Note also that this tensor is closely related to the matrix A◦A2, where ◦ denotes the componentwise product (also called the Hadamard or Schur product), as shown in (13). i = (A3)ii = 2(cid:52)(i) for all i ∈ V . It can be easily verified that, regardless of the choice of p, (cid:0)(T B)p(1)(cid:1) Random walk triangle tensor. A "random walk" normalization of the tensor T B in (7), which will be denoted by T W ∈ Rn×n×n, is entrywise defined as (cid:40) (cid:40) 1(cid:52)(j,k) 0 (cid:40) 1 (T W )ijk = if i, j, k form a triangle otherwise, (8) where (cid:52)(j, k) = (A◦ A2)jk is the number of triangles involving the edge (j, k). This is reminiscent of the random walk matrix Mij = (AD−1)ij = δij∈E/dj (here δ denotes the Kronecker delta) and this is the reason behind the choice of the name. Clustering coefficient triangle tensor. An alternative normalization in (7) gives (T C)ijk = di(di−1) 0 if i, j, k form a triangle otherwise. (9) Note that, if i, j, k form a triangle, then di ≥ 2 and hence (T C)ijk is well defined. This tensor incorporates information that is not used in (7) and (8) -- the number of transitive relationships that each node could be potentially involved in -- while also accounting for the second order structure 3 General eigenvector model 5 actually present. We refer to (12) as the clustering coefficient triangle tensor because for any p we have (T C)p(1) = c, the Watts -- Strogatz clustering coefficient vector. We will return to this property in subsection 3.3. Local closure triangle tensor. The local closure coefficient [50] of node i is defined as where w(i) = dj − di = (dj − 1) 2(cid:52)(i) w(i) , hi = (cid:88) j∈N (i) (10) (11) (cid:88) j∈N (i) (cid:40) 1 is the number of paths of length two originating from node i, and N (i) is the set of neighbours of node i. We may also write w = Ad − d = A21 − A1. The following result, which is an immediate consequence of the definition of w(i), shows that we may assume w(i) (cid:54)= 0 when dealing with real-world networks. Proposition 3.1. Let G = (V, E) be an unweighted, undirected and connected graph. Then w(i) = 0 if and only if all neighbours of node i have degree equal to one. Further, if w(i) = 0 for some i then G is either a path graph with two nodes or a star graph with n ≥ 3 nodes having i as its centre. We then define the local closure triangle tensor as (T L)ijk = w(i) 0 if i, j, k form a triangle otherwise. (12) It is easily checked that (T L)p(1) = h for all p. Next, we briefly discuss the main differences, for the purposes of this work, among these four tensorial network representations. The binary triangle tensor (7) and random walk triangle tensor (8) provide no information concerning the wedges involving each node, and hence the consequent potential for triadic closure. Indeed, networks that have very different structures from the viewpoint of potential and actual transitive relationships are treated alike. For example, consider the two networks in row (a) of Figure 1, where solid lines are used to represent the actual edges in the network. The two networks are represented by the same tensors in the case of (7) and (8), but are not equivalent from the viewpoint of transitive relationships. Indeed, by closing wedges following the principle underlying the Watts-Strogatz clustering coefficient, in the network on the left node 1 could participate in five more triangles, whilst in the graph on the right it could participate in only two more. These are highlighted in Figure 1, row (a), using dashed lines. On the other hand, the clustering coefficient triangle tensor defined in (9) encodes in its entries the "potential" for triadic closure of node 1; indeed, for the network on the left it holds that (T C)123 = (T C)132 = 1/12, while these entries are (T C)123 = (T C)132 = 1/6 for the network on the right. These values show that there is a potential for node 1 to be involved in respectively 12 and 6 directed triangles. The local closure triangle tensor defined in (12) encodes another type of triadic closure property -- the potential of a node to become involved in triangles by connecting to nodes that are at distance two from it. In the networks depicted in Figure 1, row (b), it is clear that no such triangles can be formed in the network on the left, while there is one that could be formed in the graph on the right (dashed edge). For the entries of the associated tensor T L, the left network in row (b) of Figure 1 has (T L)123 = (T L)132 = 1/2, and indeed node 1 is participating in both possible directed triangles that can be formed according to the principals of local closure. The network on the right has (T L)123 = (T L)132 = 1/3. 3.2 The linear cases: α = 1 or p = 1 The map M defined in (5) becomes linear for particular choices of p and α. One case arises when α = 1, whence it reduces to a standard matrix-vector product, M(x) = M x, and (3.1) boils down to a linear eigenvector problem (1). Using the particular choices of M described in the previous subsection, it then follows that our model includes as a special case standard eigenvector centrality and PageRank centrality. 3 General eigenvector model 6 (a) (b) 2 3 2 3 1 4 1 4 5 5 2 3 2 3 1 4 1 4 5 5 Fig. 1: Example networks with the same number of edges (solid) and triangles. Row (a), left: node 1 can be involved in five more undirected triangles according to the principle underlying the Watts -- Strogatz clustering coefficient. These are formed using the dashed edges. Row (a), right: node 1 can only be involved in two more, formed using the dashed edges. Row (b), left: node 1 cannot be involved in any more triangles, according to the principle underlying the local closure coefficient. Row (b), right: node 1 can only be involved in one more, formed using the dashed edge. Now let α ∈ [0, 1) and p = 1. Then the mapping T p : Rn → Rn also becomes linear; indeed, entrywise it becomes T 1(x)i = 1 2 T ijkxk + T ijkxj = 1 2 ( T ikj)xj + T ijk)xj j=1 k=1 j=1 (cid:110) n(cid:88) n(cid:88) n(cid:88) n(cid:88) ( k=1 n(cid:88) j,k=1 and T 1(x) reduces to the product between the vector x and the matrix with entries 1 k T ijk + T ikj). In particular, if the tensor T is symmetric with respect to the second and third modes, i.e. T ijk = T ikj for all j, k, it follows that (cid:111) 2 ((cid:80) n(cid:88) n(cid:88) ( j=1 k=1 n(cid:88) k=1 T 1(x)i = T ijk)xj . Note that this is the case for all the tensors defined in subsection 3.1. We now explicitly compute ((cid:80) T = T B is the binary triangle tensor in (7), it follows that k T ijk) for some of the tensors T presented in subsection 3.1. If (T B)ijk = (A ◦ A2)ij (13) and hence Overall, the map M then acts on a vector x as follows (T B)1(x) = (A ◦ A2)x. (cid:16) (cid:17) M(x) = αM x + (T B)1(x) = αA + (1 − α)(A ◦ A2) x, and so the solution to the constrained eigenvector problem (6) is the Perron -- Frobenius eigenvector of the matrix αA + (1− α)(A◦ A2). This has a flavour of the work in [7], where the use of A◦ A2 is advocated as a means to incorporate motif counts involving second order structure. Other choices of the tensor T yield different eigenproblems. For example, when T = T C in (9) we have n(cid:88) k=1 (T C)ijk = (cid:40) (A◦A2)ij di(di−1) 0 if di ≥ 2 otherwise 3 General eigenvector model 7 Fig. 2: C. Elegans neural network data. First four panels: scatter plots showing correlation of static clustering coefficients vs H-eigenvector coefficients for four choices of the tensor T , i.e., solutions to (15) for p = 0. The rightmost panel scatter plots degree centrality d = A1 vs standard eigenvector centrality. and hence (5) becomes M(x) = αM x + (1 − α)(T C)1(x) = (cid:16) (cid:40) (A◦A2)ij Note that in formula (14) it is possible to have(cid:80)n (T L)ijk = n(cid:88) k=1 w(i) 0 αA + (1 − α)(D2 − D)†(A ◦ A2) x, (cid:17) if dj ≥ 2 otherwise. (14) where † denotes the Moore-Penrose pseudo-inverse. If we let T = T L, as defined in (12), we obtain k=1(T L)ijk = 0 even in the case where dj ≥ 2. This is because, as observed in Proposition 3.1, there are cases where w(i) > 0 but i does not form any triangle and thus (A ◦ A2)ij = 0, for all j with dj ≥ 2. Using (14) we obtain (T L)1(x) = W †(A ◦ A2)x, where W = diag(w(1), . . . , w(n)). The eigenvector problem (6) then becomes αA + (1 − α)W †(A ◦ A2) M1,α(x) = αM x + (1 − α)(T L)1(x) = x = λ x. (cid:17) (cid:16) 3.3 Spectral clustering coefficient: α = 0 While the choice of α = 1 yields a linear and purely first order map, the case α = 0 corresponds to a map that only accounts for second order node relations. In particular, this map allows us to define spectral, and hence mutually reinforcing, versions of the Watts -- Strogatz clustering coefficient (3) and the local closure coefficient (11), where the power mean parameter p in (4) controls how the coefficients of neighbouring nodes are combined. We therefore make the following definition. Definition 3.2. Let T ∈ Rn×n×n be an entrywise nonnegative cubic tensor associated with the network. The spectral clustering coefficient of node i is the ith entry of the vector x ≥ 0 which solves the eigenvalue problem (6) with α = 0 in (5); that is, (15) The solution for T = T C ∈ Rn×n×n in (9) will be referred to as the spectral Watts -- Strogatz clustering coefficient, and the solution for T = T L ∈ Rn×n×n in (12) will be referred to as the spectral local closure coefficient. T p(x) = λx . We emphasize that, as for standard first order coefficients based on matrix eigenvectors, the spectral clustering coefficient (15) is invariant under node relabeling. Indeed, if T is any tensor associated with the network as in subsection 3.1 and π : V → V is a relabeling of the nodes, i.e., a permutation, then the tensor associated to the relabeled graph is (cid:101)T ijk = T π(i)π(j)π(k) and thus x solves (15) if and only if (cid:101)T p((cid:101)x) = λ(cid:101)x, where (cid:101)xπ(i) = xi, for all i ∈ V . Of course, the same relabeling invariance property carries over to the general setting α (cid:54)= 0. Note that if node i does not participate in any triangle, then the summation describing the corresponding entry in T p(x) is empty, and thus the spectral clustering coefficient for this node is zero, as expected. Moreover, the converse is also true, since T ≥ 0 and x ≥ 0. On the other hand, since the spectral clustering coefficient x is defined via an eigenvector equation for T p, it 00.5100.5100.5100.5100.5100.5100.5100.5100.5100.51 3 General eigenvector model 8 Fig. 3: Top 10 nodes identified on the Karate Club network by different tensor H-eigenvector clustering coefficients, solution to T p(x) = λx, for p = 0, and the four triangle tensor choices T ∈ {T B, T C, T L, T W}. follows that it cannot be unique as it is defined only up to a positive scalar multiple. Indeed, we have T p(θx) = θT p(x) for any θ ≥ 0. Hence, when T = T C, unlike the standard Watts-Strogatz clustering coefficient, it is no longer true that a unit spectral clustering coefficient identifies nodes that participate in all possible triangles. However, we will see in the next section that once we have a solution x of (15) any other solution must be a positive multiple of x. More precisely, we will show that under standard connectivity assumptions on the network, the spectral clustering coefficient and, more generally, the solution to (6) is unique up to positive scalar multiples. This fosters the analogy with the linear setting (1). Therefore, it is meaningful to normalize the solution to (6) and compare the size of its components to infer information on the relative importance of nodes within the graph. The vector T p(1), which is independent of the choice of p, defines a "static" counterpart of the spectral clustering coefficient obtained as the Perron -- Frobenius eigenvector x of T p. This may be viewed as a second order analogue of the dichotomy between degree centrality and eigenvector centrality, the former being defined as A1 and the latter as the Perron -- Frobenius eigenvector of A. As in the first order case, even though the spectral coefficient x ∝ T p(x) carries global information on the network while the static version T p(1) is highly local, the two measures can be correlated. An example of this phenomenon is shown in Figure 2, which scatter plots T p(1) against T 0(x), for different choices of T , on the unweighted version1 of the neural network of C. Elegans compiled by Watts and Strogatz in [47], from original experimental data by White et al. [48]; see Table 1 for further details of this network. We also remark that our general definition of spectral clustering coefficient in Definition 3.2 includes in the special case p → 0 the Perron H-eigenvector of the tensor T [21]. Indeed, it is easy to observe that the change of variable y2 = x yields where T yy is the tensor-vector product (T yy)i = (cid:80) T 0(x) = λx ⇐⇒ T yy = λy2, been used in the context of hypergraph centrality; see, e.g., [4]. jk T ijkyjyk. This type of eigenvector has The choice of the tensor T affects the way the triangle structure is incorporated in our measure, as we have previously illustrated in the small toy networks in Figure 1. Examples of the differences that one may obtain on real-world networks are shown in Figures 3 and 4. A description of the datasets used in those figures is provided in Section 6 and in Table 1. Figure 3 displays the Karate network and highlights the ten nodes which score the highest according to the spectral clustering coefficient for different choices of T . In this experiment we select p = 0, and thus we are actually computing the Perron H-eigenvector of the corresponding tensors. The size of each of the top ten nodes in Figure 3 is proportional to their clustering coefficients. In Figure 4, instead, we display how the H-eigenvectors corresponding to different triangle tensors correlate with the degree of the nodes for four real-world networks; We group nodes by logarithmic binning of their degree and plot the average degree versus the average clustering coefficient in each bin. As expected, the Watts -- Strogatz spectral clustering coefficient may decrease when the degree increases, in contrast with other choices of the triangle tensor. A similar phenomenon is observed, for example, in [50]. In the next section we discuss existence and uniqueness, up to scalar multiples, of a solution to (6). We also describe a power-iteration algorithm for its computation. 1 We have modified the original weighted network by assigning weight one to every edge. 4 Existence, uniqueness, maximality and computation 9 Fig. 4: Correlation of different tensor H-eigenvector clustering coefficients with node degree on four networks. We group nodes by logarithmic binning of their degree and plot the average degree versus the average clustering coefficient in each bin. 4 Existence, uniqueness, maximality and computation For reasons of clarity and utility, the definitions in Section 3 were made under the assumption that the original graph is undirected. Second order features can, of course, be incorporated in the directed case. But the range of possibilities to be considered (for example, accounting for each type of directed triangle) is much greater and the interpretation of the resulting measures becomes less clear cut. However, just as in the standard matrix setting, in terms of studying existence, uniqueness and computational issues, very little is lost by moving to the unsymmetric case. Hence, Definition 4.1 and Theorem 4.1 below are stated for general M and T . In Lemma 4.1 we then clarify that the results apply to the measures introduced in Section 3. We begin by discussing the linear case where α = 1 or p = 1, so that the nonnegative operator M : Rn → Rn is an entrywise nonnegative matrix B. Here, results from Perron -- Frobenius theory provide conditions on M that guarantee existence of a solution to (6) and computability of this solution via the classical power method. These conditions are typically based on structural prop- erties of M and of the associated graph. We review below some of the best known and most useful results from this theory. First, given the entrywise nonnegative matrix B ∈ Rn×n, let GB be the adjacency graph of B, with nodes in {1, . . . , n} and such that the edge i → j exists in GB if and only if Bij > 0. Now, recall that a graph is said to be aperiodic if the greatest common divisor of the lengths of all cycles in the graph is one. Also, the matrix B is primitive if and only if there exists an integer k ≥ 1 such that Bk > 0, and, moreover, B ≥ 0 is primitive if and only if GB is aperiodic. It is well known that when GB is strongly connected, then there exists a unique (up to multiples) eigenvector of B, and such vector is entrywise positive. Moreover, this eigenvector is maximal, since the corresponding eigenvalue is the spectral radius of B and, if GB is aperiodic, the power method iteration xk+1 = Bxk/(cid:107)Bxk(cid:107) converges to it for any starting vector x0 ∈ Rn. In the general case, we will appeal to nonlinear Perron -- Frobenius theory to show that the properties of existence, uniqueness and maximality of the solution to (6) carry over to the general nonlinear setting almost unchanged, and to show that an efficient iteration can be used to compute this solution. We first note that for any α ∈ [0, 1], any p ∈ R and any θ > 0 we have M(θx) = αM (θx) + (1 − α)T p(θx) = θM(x) , thus if x ≥ 0 solves (6), then any positive multiple of x does as well. Therefore, as for the linear case, uniqueness can only be defined up to scalar multiples. We continue by introducing the graph of M. Definition 4.1. Given a matrix M ∈ Rn×n and a cubic tensor T ∈ Rn×n×n, both assumed to be nonnegative, we define the adjacency graph GM of M in (5) as the pair GM = (V, EM) where V = {1, . . . , n} and, for all i, j ∈ V , (i, j) ∈ EM if and only if (AM)ij = 1, where AM is the adjacency matrix entrywise defined as (cid:40) if αMij + (1 − α)(cid:80)n 1 0 otherwise (AM)ij = k=1(T ijk + T ikj) > 0 We now state and prove our main theorem. 51015degree10-210-1100spectral coefficients10203040degree10-210-1100102030degree10-210-1100103060degree10-5100 4 Existence, uniqueness, maximality and computation 10 Theorem 4.1. Given the nonnegative matrix M ∈ Rn×n and the nonnegative tensor T ∈ Rn×n×n, let M be defined as in (5) and let GM be its adjacency graph, as in Definition 4.1. If GM is strongly connected, then 1. There exists a unique (up to multiples) positive eigenvector of M, i.e. a unique positive solution of (6). 2. The positive eigenvector of M is maximal, i.e., its eigenvalue is ρ(M) = max{λ : M(x) = λx}. 3. If x is any nonnegative eigenvector M(x) = λx with some zero entry, then λ < ρ(M). If moreover GM is aperiodic, then (iv) For any starting point x0 > 0, the nonlinear power method (cid:26) yk+1 = αM xk + (1 − α)T p(xk) xk+1 = yk+1/(cid:107)yk+1(cid:107) converges to the positive eigenvector of M. Moreover, for all k = 0, 1, 2, ... it holds (yk)i (xk)i with both the left and the right hand side sequences converging to ρ(M) as k → ∞. ≤ ρ(M) ≤ max (yk+1)i (xk+1)i (yk+1)i (xk+1)i ≤ max ≤ min (yk)i (xk)i i=1,...,n i=1,...,n i=1,...,n i=1,...,n min (16) Proof. The proof combines several results from nonlinear Perron -- Frobenius theory. First, note that M is homogeneous of degree one and order preserving. Indeed, if x ≥ y ≥ 0 entrywise, then it is easy to verify that M(x) = αM x + (1 − α)T p(x) ≥ αM y + (1 − α)T p(y) = M(y) ≥ 0 . It follows that M has at least one entrywise nonnegative eigenvector that corresponds to the eigenvalue λ = ρ(M) (see, e.g., [32, Theorem 5.4.1]). Next, recall that 1j denotes the jth vector of the canonical basis of Rn. Now let yj(β) = 1 + (β − 1)1j be the vector whose jth component is the variable β ∈ R while all the other entries are equal to one. Thus note that if AMij = 1, then limβ→∞ M(yj(β)i) = ∞. Since GM is strongly such that M(u) =(cid:101)λu, with(cid:101)λ > 0. connected, [19, Theorem 1] implies that M has at least one entrywise positive eigenvector u > 0 Third, we show uniqueness and maximality. Note that for any positive vector y > 0 and any p ≥ 0 we have that if GM is strongly connected then the Jacobian matrix of M evaluated at y is irreducible. In fact ∂ ∂xj M(y)i = αMij + (1 − α)yp−1 (T ijk + T ikj)µp(yj, yk)1−p . (cid:88) j radius, that must be u and we deduce that(cid:101)λ = ρ(M). Therefore, [32, Theorem 6.4.6] implies that u is the unique positive eigenvector of M. Moreover, [32, Theorem 6.1.7] implies that for any other nonnegative eigenvector x ≥ 0 with M(x) = λx we have λ < ρ(M). As there exists at least one nonnegative eigenvector corresponding to the spectral This proves points (i) − (iii). For point (iv), we note that if GM is aperiodic then AM is primitive and this implies that the Jacobian matrix of M evaluated at u > 0 is primitive as well. Thus Theorem 6.5.6 and Lemma 6.5.7 of [32] imply that the normalized iterates of the homogeneous and order preserving map M converge to u. Finally, [20, Theorem 7.1] proves the sequence of inequalities in (16) and the convergence of both the sequences M(xk)i (xk)i and βk = max i=1,...,n M(xk)i (xk)i αk = min i=1,...,n k towards the same limit; αk and βk tend to ρ(M) as k → ∞. We emphasize that because the mapping M of Theorem 4.1 is defined for an arbitrary non- negative matrix M and nonnegative tensor T , the graph GM in that theorem may be directed. The next lemma shows that when M and T are defined as in subsection 3.1 the graph GM coin- cides with the underlying network. Thus, for the undirected case and with any of the choices in subsection 3.1, Theorem 4.1 applies whenever the original graph is connected. 5 Example network with theoretical comparison 11 3 4 1 2 5 m + 1 Fig. 5: Representation of the network used in Section 5. The network is a modified wheel graph where each of the m nodes on the cycle are connected to k leaves. Lemma 4.1. Let α (cid:54)= 0 and M and T be defined according to any of the choices in subsection 3.1. Then M and AM have the same sparsity pattern; that is, Mij > 0 if and only if (AM)ij = 1. Proof. If (i, j) ∈ E is an edge in the graph associated with M, i.e. Mij > 0, then clearly (AM)ij = 1 as the tensor T has nonnegative entries. If (i, j) (cid:54)∈ E, then from the possible definitions of the tensor T listed in Subsection 3.1 it follows that T ijk = T ikj = 0, for all k. Thus (AM)ij = Mij = 0. k=1(T ijk + T ikj) = 0. Since we are summing two nonnegative terms, it follows that both are zero and, in particular, Mij = 0. If (AM)ij = 1, k=1(T ijk + T ikj) > 0 and hence at least one of the two terms has to be positive; however, from the possible definitions of T it is clear that T ijk and T ikj cannot be nonzero unless (i, j) ∈ E, i.e., unless Mij > 0. Vice versa, if (AM)ij = 0, then αMij + (1 − α)(cid:80)n on the other hand, this implies αMij + (1 − α)(cid:80)n 5 Example network with theoretical comparison In this section we describe theoretical results on the higher order centrality measures. Our overall aim is to confirm that the incorporation of second order information can make a qualitative dif- ference to the rankings. We work with networks of the form represented in Figure 5. These have three different types of nodes: i) node 1, the centre of the wheel, that has degree m and connects to m nodes of the second type, ii) m nodes attached to node 1 and interconnected via a cycle to each other. Each type (ii) node also connects to k nodes of the third type, and iii) mk leaf nodes attached in sets of k to the m nodes of type (ii). We will use node 2 to represent the nodes of type (ii) and node m + 2 to represent the nodes of type (iii). The network is designed so that node 1 is connected to important nodes and is also involved in many triangles. Node 2, by contrast, is only involved in two triangles and has connections to the less important leaf nodes. If we keep m fixed and increase the number of leaf nodes, k, then eventually we would expect the centrality of node 2 to overtake that of node 1. We will show that this changeover happens for a larger value of k when we incorporate second order information. More precisely, we set p = 1 and show that node 1 is identified by the higher-order measure as being more central than node 2 for larger values of k when compared with standard eigenvector centrality. With this labeling of the nodes, the adjacency matrix A ∈ Rn×n of the network has the form The eigenvector v = [x y1T A is such that λx = m y and it can be verified that m z1T mk]T associated to the leading eigenvalue λ = 1 + x > y if and only if k < m(m − 3). √ 1 + m + k of  A = ··· Im ⊗ 1T k 0 1T m C 0 Im ⊗ 1k 0 1m 0 ... 0  ,  C =  ∈ Rm×m . 1 ... ... 0 1 1 1 1 0 ... ... 1 5 Example network with theoretical comparison 12 Fig. 6: Values of m and k for which x > y (shaded) for different values of α, p = 1 and tensors T B (left) and T C (right). We now move on to the higher order setting. We begin by specifying the entries of the binary triangle tensor T B = (T B)ijk defined in (7). It is clear that (T B)ijk = 0 for all i = m+2, . . . , mk + m + 1. Moreover, (cid:40) (T B)1jk = 1 if j, k = 2, . . . , m + 1 are such that (j, k) ∈ E 0 otherwise, 1 if either j = 1 and (i, k) ∈ E or k = 1 and (i, j) ∈ E 0 otherwise. (cid:40) and for i = 2, . . . , m + 1 (T B)ijk = Using (4) it follows that ((T B)p(v))1 = 2my, ((T B)p(v))2 = 4µp(x, y), ((T B)p(v))m+2 = 0, where v = [x y1T m z1T mk]T as before. Overall we thus have that equation (6) rewrites as  λx = (2 − α)my λy = α(x + 2y + kz) + 4(1 − α)µp(x, y) λz = αy. For p = 1 and α ∈ (0, 1], this system yields x > y if and only if k < (cid:0)(2 − α)m2 + (α − 4)m(cid:1) . (2 − α) α2 The areas for which x > y in the two settings (standard eigenvector centrality α = 1 and higher order centrality α = 0.2, 0.5) are shaded in Figure 6 (left). It is readily seen that even for small values of m, k needs to become very large (when compared to m) in order for the centrality of nodes i = 2, . . . , m + 1 to become larger than that of node 1 when higher-order information is taken into account. In the standard eigenvector centrality setting we observe a very different behaviour (see Figure 6, left, α = 1). In Figure 6 (right) we display the areas for which x > y for different values of α when T C ∈ Rn×n×n is used in (6). Indeed, specializing the definition in (9) to this example, it is easy to see that ((T C)p(v))1 = , ((T C)p(v))2 = 4µp(x, y) (k + 3)(k + 2) , ((T C)p(v))m+2 = 0, and therefore the solution to (6) must satisfy 2y m − 1 (cid:16)  λx = (cid:17) αm + 2(1−α) m−1 y λy = α(x + 2y + kz) + 4(1−α) λz = αy. (k+3)(k+2) µp(x, y) = 0.246810010020030040050060070046810020406080100 6 Applications and numerical results 13 Name Karate Chesapeake Adjnoun C. Elegans n 34 39 112 277 m 78 170 425 1918 (cid:98)C c 0.26 0.28 0.16 0.19 0.57 0.45 0.17 0.28 (cid:52) 45 194 284 2699 xC 0.12 0.41 0.18 0.05 w 0.22 0.25 0.09 0.15 xL 0.23 0.38 0.18 0.20 Tab. 1: Description of the dataset: n is the number of nodes, m is the number of edges, (cid:52) is the number of triangles, (cid:98)C is the global clustering coefficient of the network, c is the average clustering coefficient, xC is the average spectral clustering coefficient, w is the average local closure coefficient, and xL is the average spectral local closure coefficient. After some algebraic manipulation, we obtain that x > y if and only if αm + 2(1 − α) m − 1 > λ. If we now let p = 1, it is easy to show that λ satisfies λ2 − (2α + c1)λ − (α + c1)(αm + c2) − kα2 = 0 (17) (k+3)(k+2) and c2 = 2(1−α) m−1 . with c1 = 2(1−α) Remark 5.1. Similarly, if the local closure triangle tensor T L is used in the computation, we observe that x > y if and only if αm + 2(1−α) m+2k+3 and c2 = 2(1−α) k+2 . There seems to be no appreciable difference between the profiles for α = 0.2, 0.5, 1, and hence they are not displayed here. k+2 > λ where now λ satisfies (17) for c1 = 2(1−α) 6 Applications and numerical results 6.1 Centrality measures In the previous subsection we observed that α may have a significant effect on the node rankings. Results were shown for T B and T C, p = 1 and α = 0.2, 0.5, 1. In this subsection we test the role of α for real network data. We use α = 0.5 and α = 1 (corresponding to eigenvector centrality) and p = 0 in (6), and combine the adjacency matrix A and the binary tensor T B. Our tests were performed on four real-world networks which are often used as benchmarks in the graph clustering and community detection communities, and are publicly available at [12]. The Karate network is a social network representing friendships between the 34 members of a karate club at a US university [52]. The network C. Elegans is a neural network. We use here an undirected and unweighted version of the neural network of C. Elegans compiled by Watts and [48]. The network Adjnoun Strogatz in [47], from original experimental data by White et al. is based on common adjective and noun adjacencies in the novel "David Copperfield" by Charles Dickens [41]. Chesapeake represents the interaction network of the Chesapeake Bay ecosystem. Here, nodes represent species or suitably defined functional groups and links create the food web [2]. In Table 1 we report the number of nodes n, (undirected) edges m and triangles (cid:52) = trace(A3)/6 for the four networks. We further display the global clustering coefficient (cid:98)C, the average clustering coefficient c, and the average spectral clustering coefficient xC, as well as the average local closure coefficient w [50] and its spectral counterpart xL; see Defintion 3.2. Figure 7 scatter plots the newly introduced measure against eigenvector centrality for the four different networks. The centrality vectors are normalized with the infinity norm. For the network Karate we see very poor correlation between the two measures. Stronger correlation is displayed for the other networks, but it is still to be noted that the top ranked nodes (corresponding to the nodes with largest centrality scores) differ for the two measures in all but one network, namely Adjnoun. Hence, using second order information can alter our conclusions about which nodes are the most central. 6.2 Link Prediction Link prediction is a fundamental task in network analysis: given a network G0 = (V, E0), we must identify edges that are not in E0 but should be there. This problem typically arises in two settings: 6 Applications and numerical results 14 Fig. 7: Scatter plot of the solution to (6) with M = A and T = T B. The plot shows the solution for α = 0.5 and p = 0 versus standard eigenvector centrality, i.e., (6) for α = 1. (a) in a dynamic network where new connections appear over time, and (b) in a noisily observed network, where it is suspected that edges are missing [11, 34, 35]. For convenience, let us assume that E0 is the set of edges that we observe and that E1 with E1 ∩ E0 = ∅ is the set of edges that should be predicted, i.e., those that will appear in an evolving network or that are missing in a noisy graph. A standard approach for link prediction is to create a similarity matrix S, whose entries Sij quantify the probability that (i, j) ∈ E1. It is worth pointing out that since E0 ∩ E1 = ∅, then the nonzero pattern of S will be complementary to that of the adjacency matrix of G0. Over the years, several similarity measures have been proposed in order to quantify which nodes are most likely to link to a given node i [37]. While classical methods usually exploit the first order structure of connections around i, there is a growing interest in second order methods that take into account, for example, triangles. In this context, we propose a new similarity measure based on M and its Perron eigenvector. This measure is a generalization of a well-known technique known as seeded (or rooted) PageRank [23, 29], which we now describe. Given a seed node (cid:96) ∈ V and a teleportation coefficient 0 ≤ c < 1, let x((cid:96)) be the limit of the evolutionary process (18) where P is the random walk matrix P = AD−1. As 0 ≤ c < 1, it is easy to show that the limit exists and that it coincides with the solution to the linear system k = 0, 1, 2, . . . xk+1 = cP xk + (1 − c)1(cid:96), (I − cP )x((cid:96)) = (1 − c)1(cid:96) . (19) The seeded PageRank similarity matrix SP R is then entrywise defined by (SP R)ij = (x(i))j + (x(j))i . The idea behind (18) is that the sequence xk is capturing the way a unit mass centered in (cid:96) (the seed or root of the process), and represented in the model by 1(cid:96), propagates throughout the network following the diffusion rule described by P . This diffusion map is a first order random walk on the graph. In order to propose a new, second order, similarity measure, we replace this first order map with the second order diffusion described by M = αM + (1− α)T p and we consider the associated diffusion process. To this end, we begin by observing that, independently of the choice of the starting point x0 in (18), the first order diffusion process will always converge to x((cid:96)) that satisfies (cid:107)x((cid:96))(cid:107)1 = 1. Indeed, (19) yields (cid:107)x((cid:96))(cid:107)1 = (1 − c)(cid:107)(cid:88) k≥0 ckP k1(cid:96)(cid:107)1 = (1 − c) ck = 1 . (cid:88) k≥0 As a consequence, the limit of the sequence (18) coincides with the limit of the normalized iterates xk+1 = cP xk + (1− c)1(cid:96), with xk+1 = xk+1/(cid:107)xk+1(cid:107)1. On the other hand, when the linear process P is replaced by the nonlinear map M, the unnormalized sequence may not converge. We thus need to impose normalization of the vectors in our dynamical process defined in terms of M and seeded in the node (cid:96): yk+1 = cM(yk) + (1 − c)1(cid:96) yk+1 = yk+1/(cid:107)yk+1(cid:107)1. k = 0, 1, 2, . . . (20) 00.51 = 100.51 = 0.5Karate00.51 = 100.51Adjnoun00.51 = 100.51Chesapeake00.51 = 100.51C. Elegans 6 Applications and numerical results 15 Fig. 8: Link prediction performance comparison on two network dataset: UK faculty dataset (top) and Small World citation network (bottom). The plots show means and quartiles of the ratio between the fraction of correctly predicted edges using SM and the one obtained using SP R, over ten random trials for different values of p and α in (5). Note that, for α = 1 and M = P in (5) we retrieve exactly the rooted PageRank diffusion (18). Unlike the linear case, the convergence of the second order nonlinear process (20) is not straightforward. However, ideas from the proof of Theorem 4.1 can be used to show that the convergence is guaranteed for any choice of the tensor T , of the matrix M, and of the starting point y0 ≥ 0, provided that the graph GM is aperiodic. Corollary 6.1. Let M : Rn → Rn be as in Definition 3.1 and let GM be its adjacency graph, as per Definition 4.1. If GM is aperiodic and y0 > 0, then yk defined in (20) for a given seed (cid:96) converges to a unique stationary point y((cid:96)) > 0. Proof. Let F : Rn → Rn be the map F(y) = cM(y) + (1 − c)(cid:107)y(cid:107)11(cid:96), where we have omitted the dependency of the map on (cid:96) for the sake of simplicity. Note that the limit points of (20) coincide with the fixed points of F on the unit sphere (cid:107)y(cid:107)1 = 1. Note moreover that F is homogeneous, i.e., F(θy) = θF(y), for all θ > 0. Finally, notice that the j-th column of the Jacobian matrix of F evaluated at z is ∂ ∂yj M(z) + (1 − c)1(cid:96) , F(z) = c ∂ ∂yj which shows that if the Jacobian of M is irreducible, the same holds for the Jacobian of F. With these observations, the thesis follows straightforwardly using the same arguments as in the proof of Theorem 4.1, applied to F. As for the linear dynamical process, the stationary distributions of (20) computed for different seeds allow us to define the similarity matrix SM: (SM)ij = (y(i))j + (y(j))i. In Figure 8 we compare the performance of the link prediction algorithm based on the standard seeded PageRank similarity matrix SP R (18) and the newly introduced similarity matrix SM (20) induced by M with M = P and T = T W , the random walk triangle tensor. The tests were performed on the real-world networks UK faculty and Small World citation. The network 00.25 0.5 1 1.5 20.511.522.533.5Relative performance ratio vs PageRank0.10.20.50.80.9 10.511.522.533.544.55 00.25 0.5 1 1.5 20.511.522.5Relative performance ratio vs PageRank0.10.20.50.80.9 111.522.53 7 Conclusion 16 UK faculty[39] represents the personal friendships network between the faculty members of a UK University. The network contains n = 81 vertices and m = 817 edges. The network Small World citation [18] represents citations among papers that directly cite Milgram's small world paper or contain the words "Small World" in the title. This network contains n = 233 nodes and m = 994 edges. We transformed both networks by neglecting edge directions and weights. The experiments were performed as follows. We start with an initial network G = (V, E) and we randomly select a subset of its edges, which we call E1, of size E1 ≈ E/10. We then define G0 = (V, E0) to be the graph obtained from G after removal of the edges in E1, so that E0 = E\E1. Thus, working on the adjacency matrix of G0, we build the two similarity matrices SP R and SM. Then, for each similarity matrix S, we select from V × V \ E0 the subset ES containing the E1 edges with the largest similarity scores Sij. A better performance corresponds to a larger size of E1 ∩ ES, since this is equivalent to detecting more of the edges that were originally in the graph. To compare the performance of the two similarity matrices, we thus computed the ratio ESM ∩ E1/ESP R ∩ E1. In Figure 8 we boxplot this quantity over 10 random runs where E1 is sampled from the initial E with a uniform probability. Whenever the boxplot is above the threshold of 1, our method is outperforming standard seeded PageRank. The middle plots in the figure display the results for the two networks when α = 0.5 in (5) and we let p vary. On the other hand, the plots on the right display results for varying values of α and p = 0, which was observed to achieve the best performance in the previous test. Overall, the link prediction algorithm based on the similarity matrix SM typically outperforms the alternative based on SP R, especially for small values of p. 7 Conclusion After associating a network with its adjacency matrix, it is a natural step to formulate eigenvalue problems that quantify nodal characteristics. In this work we showed that cubic tensors can be used to create a corresponding set of nonlinear eigenvalue problems that build in higher order effects; notably triangle-based motifs. Such spectral measures automatically incorporate the mutually reinforcing nature of eigenvector and PageRank centrality. As a special case, we specified a mutually reinforcing version of the classical Watts -- Strogatz clustering coefficient. We showed that our general framework includes a range of approaches for combining first and second order interactions, and, for all of these, we gave existence and uniqueness results along with an effective computational algorithm. Synthetic and real networks were used to illustrate the approach. Given the recent growth in activity around higher order network features [5, 4, 6, 10, 14, 27, 28, 31, 33, 46, 49, 50, 51], there are many interesting directions in which this work could be further developed, including the design of such centrality measures for weighted, directed and dynamic networks, and the study of mechanistic network growth models that incorporate higher-order information. Data and funding The data used in this work is available in the public domain, as indicated in the text. The code used in the experiments is available at https://github.com/ftudisco/SpectralClCoeff. The three authors contributed equally to the manuscript. The work of FA was supported by fellowship ECF-2018-453 from the Leverhulme Trust. The work of DJH was supported by EPSRC/RCUK Established Career Fellowship EP/M00158X/1 and by EPSRC Programme Grant EP/P020720/1. The work of FT was partially supported by INdAM -- GNCS and by EPSRC Programme Grant EP/P020720/1. References [1] N. K. Ahmed, R. Rossi, J. B. Lee, T. L. Willke, R. Zhou, X. Kong, and H. Eldardiry. Learning role-based graph embeddings. arXiv preprint arXiv:1802.02896, 2018. [2] D. Baird and R. E. Ulanowicz. The seasonal dynamics of the Chesapeake Bay ecosystem. Ecological monographs, 59(4):329 -- 364, 1989. 7 Conclusion 17 [3] P. S. Bearman and J. Moody. Suicide and friendships among american adolescents. American Journal of Public Health, 94(1):89 -- 95, 2004. [4] A. R. Benson. Three hypergraph eigenvector centralities. SIAM Journal on Mathematics of Data Science, 1:293 -- 312, 2019. [5] A. R. Benson, R. Abebe, M. T. Schaub, A. Jadbabaie, and J. Kleinberg. Simplicial clo- sure and higher-order link prediction. Proceedings of the National Academy of Sciences, 115(48):E11221 -- E11230, 2018. [6] A. R. Benson, D. F. Gleich, and J. Leskovec. Tensor spectral clustering for partitioning higher- order network structures. In Proceedings of the 2015 SIAM International Conference on Data Mining, pages 118 -- 126. SIAM, 2015. [7] A. R. Benson, D. F. Gleich, and J. Leskovec. Higher-order organization of complex networks. Science, 353(6295):163 -- 166, 2016. [8] G. Bianconi, R. K. Darst, J. Iacovacci, and S. Fortunato. Triadic closure as a basic generating mechanism of communities in complex networks. Physical Review E, 90(4):042806, 2014. [9] G. Carlsson. Topology and data. Bulletin of the American Mathematical Society, 46(2):255 -- 308, 2009. [10] P. S. Chodrow. Configuration models of random hypergraphs and their applications. arXiv preprint arXiv:1902.09302, 2019. [11] A. Clauset, C. Moore, and M. E. Newman. Hierarchical structure and the prediction of missing links in networks. Nature, 453(7191):98, 2008. [12] T. Davis, W. Hager, and I. Duff. Suitesparse. htt p://faculty. cse. tamu. edu/davis/suitesparse. html, 2014. [13] H. Edelsbrunner and J. Harer. Computational Topology: An Introduction. Applied Mathe- matics. American Mathematical Society, 2010. [14] N. Eikmeier and D. F. Gleich. Classes of preferential attachment and triangle preferential attachment models with power-law spectra. Journal of Complex Networks, (To appear). [15] J. Enright and R. R. Kao. Epidemics on dynamic networks. Epidemics, 24:88 -- 97, 2018. [16] E. Estrada. When local and global clustering of networks diverge. Linear Algebra and its Applications, 488:249 -- 263, 2016. [17] E. Estrada and F. Arrigo. Predicting triadic closure in networks using communicability dis- tance functions. SIAM Journal on Applied Mathematics, 75(4):1725 -- 1744, 2015. [18] E. Garfield and A. I. Pudovkin. The HistCite system for mapping and bibliometric analysis of the output of searches using the ISI Web of Knowledge. In Proceedings of the 67th Annual Meeting of the American Society for Information Science and Technology, pages 12 -- 17, 2004. [19] S. Gaubert and J. Gunawardena. The perron-frobenius theorem for homogeneous, monotone functions. Transactions of the American Mathematical Society, 356(12):4931 -- 4950, 2004. [20] A. Gautier, F. Tudisco, and M. Hein. The Perron-Frobenius theorem for multihomogeneous mappings. SIAM Journal on Matrix Analysis and Applications, 40:1179 -- 1205, 2019. [21] A. Gautier, F. Tudisco, and M. Hein. A unifying Perron -- Frobenius theorem for nonnegative tensors via multihomogeneous maps. SIAM Journal on Matrix Analysis and Applications, 40(3):1206 -- 1231, 2019. [22] M. Girvan and M. E. Newman. Community structure in social and biological networks. Proceedings of the National Academy of Sciences, 99(12):7821 -- 7826, 2002. [23] D. Gleich and K. Kloster. Seeded pagerank solution paths. European Journal of Applied Mathematics, 27(6):812 -- 845, 2016. 7 Conclusion 18 [24] D. F. Gleich. PageRank beyond the web. SIAM Review, 57(3):321 -- 363, August 2015. [25] P. Grindrod, D. J. Higham, and M. C. Parsons. Bistability through triadic closure. Internet Mathematics, 8:402 -- 423, 2012. [26] K. Henderson, B. Gallagher, T. Eliassi-Rad, H. Tong, S. Basu, L. Akoglu, D. Koutra, C. Faloutsos, and L. Li. Rolx: structural role extraction & mining in large graphs. In Proceedings of the 18th ACM SIGKDD international conference on Knowledge discovery and data mining, pages 1231 -- 1239. ACM, 2012. [27] L. Huang, C.-D. Wang, and H.-Y. Chao. Higher-order multi-layer community detection. In Proceedings of the AAAI Conference on Artificial Intelligence, volume 33, pages 9945 -- 9946, 2019. [28] I. Iacopini, G. Petri, A. Barrat, and V. Latora. Simplicial models of social contagion. Nature Communications, 10:2485, 2019. [29] G. Jeh and J. Widom. Scaling personalized web search. In Proceedings of the 12th international conference on World Wide Web, pages 271 -- 279. Acm, 2003. [30] T. LaFond, J. Neville, and B. Gallagher. Anomaly detection in networks with changing trends. In Outlier Detection and Description under Data Diversity at the International Conference on Knowledge Discovery and Data Mining, 2014. [31] R. Lambiotte, M. Rosvall, and I. Scholtes. From networks to optimal higher-order models of complex systems. Nature Physics, page 1, 2019. [32] B. Lemmens and R. D. Nussbaum. Nonlinear Perron-Frobenius theory. Cambridge University Press, general edition, 2012. [33] P. Li, G. J. Puleo, and O. Milenkovic. Motif and hypergraph correlation clustering. IEEE Transactions on Information Theory, 2019. [34] D. Liben-Nowell and J. Kleinberg. The link-prediction problem for social networks. Journal of the American Society for Information Science and Technology, 58(7):1019 -- 1031, 2007. [35] L. Lü and T. Zhou. Link prediction in complex networks: A survey. Physica A: Statistical Mechanics and its Applications, 390(6):1150 -- 1170, 2011. [36] R. D. Luce and A. D. Perry. A method of matrix analysis of group structure. Psychometrika, 14(2):95 -- 116, 1949. [37] V. Martínez, F. Berzal, and J.-C. Cubero. A survey of link prediction in complex networks. ACM Computing Surveys (CSUR), 49(4):69, 2017. [38] P. N. McGraw and M. Menzinger. Clustering and the synchronization of oscillator networks. Physical Review E, 72(1):015101, 2005. [39] T. Nepusz, A. Petróczi, L. Négyessy, and F. Bazsó. Fuzzy communities and the concept of bridgeness in complex networks. Physical Review E, 77:016107, Jan 2008. [40] M. E. Newman. The structure of scientific collaboration networks. Proceedings of the National Academy of Sciences, 98(2):404 -- 409, 2001. [41] M. E. Newman. Finding community structure in networks using the eigenvectors of matrices. Physical review E, 74(3):036104, 2006. [42] M. E. J. Newman. Networks: an Introduction. Oxford Univerity Press, Oxford, 2010. [43] N. Otter, M. A. Porter, U. Tillmann, P. Grindrod, and H. A. Harrington. A roadmap for the computation of persistent homology. EPJ Data Science, 6, 2017. [44] J. P. Schäfermeyer. On Edmund Landau's contribution to the ranking of chess players. Un- published manuscript, 2019. 7 Conclusion 19 [45] T. Schank and D. Wagner. Finding, counting and listing all triangles in large graphs, an In International Workshop on Experimental and Efficient Algorithms, experimental study. pages 606 -- 609. Springer, 2005. [46] F. Tudisco, F. Arrigo, and A. Gautier. Node and layer eigenvector centralities for multiplex networks. SIAM Journal on Applied Mathematics, 78(2):853 -- 876, 2018. [47] D. J. Watts and S. H. Strogatz. Collective dynamics of 'small-world' networks. Nature, 393:440 -- 442, 1998. [48] J. G. White, E. Southgate, J. N. Thomson, and S. Brenner. The structure of the nervous sys- tem of the nematode caenorhabditis elegans. Philosophical Transactions of the Royal Society B: Biological Sciences, 314(1165):1 -- 340, 1986. [49] H. Yin, A. R. Benson, and J. Leskovec. Higher-order clustering in networks. Physical Review E, 97(5):052306, 2018. [50] H. Yin, A. R. Benson, and J. Leskovec. The local closure coefficient: a new perspective on In Proceedings of the Twelfth ACM International Conference on Web network clustering. Search and Data Mining, pages 303 -- 311. ACM, 2019. [51] H. Yin, A. R. Benson, J. Leskovec, and D. F. Gleich. Local higher-order graph clustering. In Proceedings of the 23rd ACM SIGKDD International Conference on Knowledge Discovery and Data Mining, pages 555 -- 564. ACM, 2017. [52] W. W. Zachary. An information flow model for conflict and fission in small groups. Journal of Anthropological Research, 33:452 -- 473, 1977.
1802.06055
1
1802
2018-02-16T18:04:39
Computationally Inferred Genealogical Networks Uncover Long-Term Trends in Assortative Mating
[ "cs.SI", "physics.soc-ph", "q-bio.PE" ]
Genealogical networks, also known as family trees or population pedigrees, are commonly studied by genealogists wanting to know about their ancestry, but they also provide a valuable resource for disciplines such as digital demography, genetics, and computational social science. These networks are typically constructed by hand through a very time-consuming process, which requires comparing large numbers of historical records manually. We develop computational methods for automatically inferring large-scale genealogical networks. A comparison with human-constructed networks attests to the accuracy of the proposed methods. To demonstrate the applicability of the inferred large-scale genealogical networks, we present a longitudinal analysis on the mating patterns observed in a network. This analysis shows a consistent tendency of people choosing a spouse with a similar socioeconomic status, a phenomenon known as assortative mating. Interestingly, we do not observe this tendency to consistently decrease (nor increase) over our study period of 150 years.
cs.SI
cs
Computationally Inferred Genealogical Networks Uncover Long-Term Trends in Assortative Mating Eric Malmi Aalto University Espoo, Finland [email protected] Aristides Gionis Aalto University Espoo, Finland [email protected] Arno Solin Aalto University Espoo, Finland [email protected] 8 1 0 2 b e F 6 1 ] I S . s c [ 1 v 5 5 0 6 0 . 2 0 8 1 : v i X r a ABSTRACT Genealogical networks, also known as family trees or population pedigrees, are commonly studied by genealogists wanting to know about their ancestry, but they also provide a valuable resource for disciplines such as digital demography, genetics, and computational social science. These networks are typically constructed by hand through a very time-consuming process, which requires comparing large numbers of historical records manually. We develop computa- tional methods for automatically inferring large-scale genealogical networks. A comparison with human-constructed networks attests to the accuracy of the proposed methods. To demonstrate the ap- plicability of the inferred large-scale genealogical networks, we present a longitudinal analysis on the mating patterns observed in a network. This analysis shows a consistent tendency of people choosing a spouse with a similar socioeconomic status, a phenome- non known as assortative mating. Interestingly, we do not observe this tendency to consistently decrease (nor increase) over our study period of 150 years. KEYWORDS genealogy; family tree; pedigree; population reconstruction; prob- abilistic record linkage; assortative mating; social stratification; homogamy 1 INTRODUCTION Where do we come from? What are we? Where are we going? These questions, posed by the famous painter Paul Gauguin, resonate with many people. An example of the allure of the first question can be attested in the popularity of genealogy, the study of family history. Genealogical research is typically conducted by studying a large number of historical vital records, such as birth and marriage records, and trying to link records referring to the same person. This process is nowadays facilitated by numerous popular online ser- vices, such as Ancestry.com, MyHeritage, and Geni, and increasingly with genetic analysis. Nevertheless, constructing a genealogical network (also known as family tree or population pedigree) is still a very time consuming process, entailing lots of manual work. In recent years, lots of efforts have been focused on indexing historical vital records available in physical archives as well as in online repositories in the format of scanned images. Crowdsourcing projects organized, for example, by online genealogy services aim to do this kind of research by attracting people capable of inter- preting old handwriting. Furthermore, there are also recent efforts at developing new optical character recognition (OCR) techniques to automate the process [13]. The availability of indexed records Figure 1: A subgraph of a genealogical network automati- cally inferred by linking birth records. The subgraph spans 13 generations. makes genealogical research amenable to new computer-supported and, to some extent, even fully-automatic approaches. Our goal in this paper is to develop novel computational methods for inferring large-scale genealogical networks by linking vital records. We propose two supervised inference methods, BinClass and Collective, which we train and test on Finnish data from the mid 17th to the late 19th century. More specifically, we apply these methods to link a large collection of indexed vital records from Finland, constructing a genealogical network whose largest component contains 2.6 million individuals. A small subgraph of this component is visualized in Figure 1, where people are colored by their social class which is based on their father's occupation. The class information is used later when analyzing assortative mating. The construction of the full network takes only about one hour, which shows that it is vastly more scalable than the traditional manual approach which would probably require at least dozens of man-years for the same task. However, at its current stage, the accuracy of the automatic approach is not comparable 1.Upperandmiddleclass2.Peasants3.Crofters4.LabourersUnknown to a careful human genealogist, but it can still support the work of the genealogist by providing the most probable parents for each individual, narrowing the search space. From the methodological point of view, the main idea behind the proposed approaches is to cast the network-inference task into mul- tiple binary classification tasks. Furthermore, our second approach, Collective, aims at capturing the observation that people tend to have children with the same partner, so if, for example, a father has multiple children, the mothers of the children should not be in- ferred independently. Incorporating this notion to our optimization problem, interestingly, leads to the well-known facility-location problem as well as an increase in the accuracy of the links. In addition to family history, genealogical networks can be ap- plied to several other domains, such as digital demography [30], genetics, human mobility, epidemiology, and computational social science. In this work, we demonstrate the applicability of the in- ferred network by analyzing assortative mating, that is, a general tendency of people to choose a spouse with a similar socioeconomic background. Mating choices have been shown to be an important driver for income inequality [14]. From the perspective of computational social science [21], ge- nealogical networks offer particularly interesting analysis oppor- tunities because of the long time window these networks cover. Compared to social-media data, which is typically used for compu- tational social-science studies, genealogical networks contain less granular data about the people in the network, but they allow us to observe phenomena that occur over multiple generations. This aspect of genealogical networks enables us to quantify long-term trends in our society, as done for assortative mating in this work. Therefore, genealogical networks can provide answers not only to the first question asked in the beginning of this section but also to the third one: Where are we going? Our main contributions in this paper are summarized as follows: • We propose a principled probabilistic method, BinClass, for inferring large-scale genealogical networks by linking vital records. • We perform an experimental evaluation, which shows that 61.6% of the links inferred by BinClass are correct. The accu- racy obtained by BinClass surpasses the accuracy (56.9%) of a recently proposed NaiveBayes method [24]. Furthermore, we show that the link probability estimates provided by Bin- Class can be used to reliably control the precision–recall trade-off of the inferred network. • We present a novel inference method, called Collective, which aims to improve disambiguation of linked entities, and does so by considering the genealogical-network inference task as a global optimization task, instead of inferring family relationships independently. Collective further improves the overall link accuracy to 65.1%. However, contrasted to BinClass, Collective does not provide link probabilities. • Finally, we demonstrate the relevance and applicability of automatically inferred genealogical networks by performing an analysis on assortative mating. The analysis suggests that assortative mating existed in Finland between 1735 and 1885, but it did not consistently decrease or increase during this period. 2 DATA Our genealogical network inference method is based on linking vital records. The method is trained and evaluated using a human- constructed network. Next, we present these two data sources. 2.1 Population Records The Swedish Church Law 1686 obliged the parishes in Sweden (and in Finland, which used to be part of Sweden) to keep records of births, marriages, and burials, across all classes of the society. The 'HisKi' project, an effort started in the 1980s, aims to digitally index the hand-written Finnish parish registers. The digitized data contains about 5 million records of births and a total of 5 million records of deaths, marriages and migration. The HisKi dataset is publicly available at http://hiski.genealogia.fi/hiski?en, except for the last 100 years due to current legislation. Each birth record typically contains the name, birth place, and birth date of the child in addition to the names and occupations of the parents. The goal of the genealogical network inference problem is to link the birth records to the birth records of the parents, creating a family tree with up to millions of individuals. Currently, we only have access to data from Finland, but similar indexed datasets can be expected to become available for other countries through projects such as READ1 which develop optical character recognition (OCR) methods for historical hand-written documents. 2.2 Ground Truth We have obtained a genealogical network consisting of 116 640 individuals constructed by an individual genealogist over a long period of time. To use this network as a ground truth, we first match these individuals to the birth records in the HisKi dataset. An individual is considered matched if we find exactly one birth record with the same normalized first name and last name and the same birth date. Then, we find parent–child edges where both individuals are matched to a birth record, yielding 18 731 ground- truth links. Finally, the ground-truth links are split into a training set (70%) and a test set (30%). This is done by computing the connected components of the network, sorting the components by size in descending order, and assigning the nodes into two buckets in a round-robin fashion: First, assign the largest component to the training set. Second, assign the second largest component to the test set. Continue alternating between the buckets, however, skipping a bucket if its target size has been reached. Compared to directly splitting people into the two buckets, this approach ensures that there are no edges going across the two buckets that would thus be lost. In the end, we get 5 631 test links out of which 42% are between mother and a child. 3 GENEALOGICAL NETWORK INFERENCE Genealogical networks are typically constructed manually by link- ing vital records, such as birth, marriage, and death certificates. The main challenges in the linking process are posed by duplicate names, spelling variations and missing records. 1https://read.transkribus.eu/ 2 3.1 Problem Definition A genealogical network is defined as a directed graph where the nodes correspond to people and the edges correspond to family relationships between them. We consider only two type of edges: father edges, going from a father to a child, and mother edges, going from a mother to a child. Each node can have at most one biological father and mother, but they are not necessarily known. Because of the temporal ordering of the nodes, this graph is a directed acyclic graph (DAG). Each person in the graph is represented by the person's birth record. Given a set of birth records V , the objective of the genealog- ical network inference is to link each birth record a ∈ V to the birth records of the person's mother Ma ∈ V and father Fa ∈ V . In addition to the birth records, the inference method gets as input a set of mother candidates Cm ⊆ V and a set of father candidates Cf ⊆ V for each child. In each method studied in this paper, the candidate sets are defined as the people who were born between 10 and 70 years before the child and whose normalized first and last name match to the parent name mentioned in the child's record.2 Since the true parents are ambiguous, the output should be a probability distribution over different parent candidates, including the case ∅ that a parent is not among the candidates. 3.2 Naive Bayes Baseline This baseline method [24] first constructs an attribute similarity vector γ for each (child, candidate parent) pair. The vector consists of the following five features: a Jaro–Winkler name similarity for first names, last names and patronyms, and the age difference as well as the birth place distance between the child and the parent. Assuming that the family links are independent, the probability of each mother candidate m (and similarly of each father candidate) for person a can be written as follows, using the Bayes' rule , (1)  m′∈Cm p(cid:0)Ma = m γ(cid:1) = where p (Ma = m) is the prior probability of m and p(cid:0)γa,m Ma = m(cid:1) p (Ma = m) p(γ a,m Ma =m) p(γ a,m Ma (cid:44)m) a ∪∅ p (Ma = m′) p(γ a,m′ Ma =m′) p(γ a,m′ Ma (cid:44)m′) denotes the likelihood of observing the attribute similarities γa,m. The derivation of Equation (1) is given in the earlier work of Malmi et al. [24], and we adopt it in this paper. Since the links are assumed to be independent, the log-likelihood function over all links is given by the sum of the link log-probabilities. Let xa,m ∈ {0, 1} be a random variable denoting whether person a 2The names are normalized with a tool developed by the authors of [24], which is available at: https://github.com/ekQ/historical_name_normalizer 3 is linked to parent m. This allows us to write the likelihood func- tion as max x (cid:20) log p(cid:0)Ma = m γ(cid:1) xa,m + log p(cid:0)Fa′ = f γ(cid:1) xa′,f such that   a′,f xa,m = 1, for all a, a,m m (cid:21) xa,f = 1, for all a, f (2) (3) (4) xa,m, xa,f ∈ {0, 1}, for all a, m, f . (5) The maximum likelihood solution for this non-collective genealog- ical network inference problem can be obtained simply by optimiz- ing the parent links independently. The method assumes that the components of γa,m, corresponding to different attribute similari- ties, are also independent. Therefore, we call this method Naive- Bayes. Next we present the two methods proposed in this paper, which improve over NaiveBayes. (cid:17) (cid:16) γ a,m i Ma = m 3.3 Binary-Classification Approach The key observation behind this approach is that likelihood ratios can be approximated with probabilistic discriminative classifiers [9]. This means that instead of estimating the component-wise prob- ability distributions p , as done in NaiveBayes, we can approximate the two likelihood ratios in (1) by training a probabilistic binary classifier to separate attribute similarity vectors γa,m corresponding to matching and non-matching (child, candi- date parent) pairs. The most straightforward approximation is given by p(cid:0)γa,m Ma (cid:44) m(cid:1) ≈ s(cid:0)γa,m(cid:1) p(cid:0)γa,m Ma = m(cid:1) 1 − s(cid:0)γa,m(cid:1) , where s(cid:0)γa,m(cid:1) ∈ [0, 1] is the output of a probabilistic binary classi- fier trained to separate matching γa,m vectors from non-matching ones. In some cases, the probabilities predicted by the classifier can be distorted, which can be countered by calibrating the probabili- ties [26]. We choose XGBoost [6] as the classifier s since it has been suc- cessfully employed for a record linkage task [22, 28] as well as other classification tasks previously. In our case, the probabilities predicted by the XGBoost classifier are fairly accurate (calibration does not improve the Brier score [4] of the classifier) so calibration is not used. This approach is called BinClass. The key advantages that BinClass offers over NaiveBayes are: (i) we do not have to make the independence assumption for at- tribute similarities, (ii) we can use any existing classifier that pro- vides probabilities as output, and (iii) it is very easy to add new features to the attribute similarity vector and retrain the model, whereas in NaiveBayes we have to estimate two new likelihood dis- tributions for each new feature, which requires manually selecting a suitable distribution based on the type of the new feature. In total, we use 20 attribute similarity features γ, which can be grouped into the following categories: (1) Candidate age : The age of the candidate parent at the time of the child's birth and the difference to the reported parent age if available (for mothers, an approximated age is reported in 40% of the birth records). (2) Geographical distance : The distance between the birth places of the child and the candidate parent. (3) Names : The similarity of the first names, middle names (if any), last names, and patronyms reported in the child's record for the parent and in the candidate's record for the child. (4) NaiveBayes : The probability estimated by the NaiveBayes (5) Gender : A binary variable indicating whether we are match- method is used as a feature. ing a father or a mother. (6) Location : The coordinates of the child's birth location. (7) Birth year : The birth year of the child. (8) Candidate death : A binary variable indicating whether there is a non-ambiguous death record, which indicates that the candidate had died before the birth of the child, and another variable indicating how long before the birth the death occurred (0 if it is not known to occur before the birth). Feature groups (6)–(8) as well as middle name and patronym simi- larities are not used by the NaiveBayes model. Feature groups (6) and (7) are not useful on their own, since they are the same for each candidate parent of a child, but they might be informative together with other features. For instance, name similarity patterns might be time- or location-dependent. To compute the features regarding the death year of the candidate (feature group (8)), we first match the death records to birth records by finding the record pairs that (i) have the same normalized first name, last name, and patronym, (ii) for which the reported age at death matches to the birth year ±1 year, and (iii) the birth and the death location are at most 60 kilometers apart. Then we link a death record to a birth record only if the death record has only one feasible match. This approach allows us to infer the death time for 12% of the birth records.3 3.4 Collective Approach Both NaiveBayes and BinClass assume that the family links are independent, which leads to some unlikely outcomes. In particular, the number of spouses per person becomes unrealistically high which is illustrated in Figure 2 which shows a subgraph inferred by NaiveBayes. The algorithm has inferred a person called Anders Tihoin to have fathered six children-each with a different mother. While this is possible, it is very likely that at least the mothers of Catharina (the left one), Anna Helena and Anders are actually the same person, since the mother's name for these children is almost the same (Maria Airaxin(en)). To address this problem, we propose to minimize the number mother–father pairs in addition to maximizing the probability of the inferred links. Let ym,f ∈ {0, 1} indicate whether any child has been assigned to mother–father pair (m, f ). Now we can write the 3Based on the ground-truth data (Section 2.2), 96.4% of the obtained death record matches are correct, but we are able to match only 18% of the 3.3 million death records. Ideally, the death record matching should be done in a probabilistic way, jointly with the birth record linking. 4 Figure 2: A sample subnetwork inferred by NaiveBayes with colors corresponding to gender. If each child is matched to the most probable father–mother pair independently, the number of spouses per person can be unrealistically high. log p(cid:0)Ma = m γ(cid:1) xa,m collective genealogical network inference problem as − λ max x,y (cid:20)  ym,f + + log p(cid:0)Fa′ = f γ(cid:1) xa′,f such that   a′,f xa,mxa,f ≤ ym,f ,  a,m m,f (cid:21) (6) (7) (8) for all m, f , a m xa,m = 1, xa,f = 1, for all a, f xa,m, xa,f , ym,f ∈ {0, 1}, (9) where λ ≥ 0 controls the penalty induced by each extra parent pair (or discount for merging two parent pairs into one). for all a, m, f , This optimization problem is an instance of the uncapacitated facility-location problem, where parent pairs correspond to facil- ities, child nodes to demand sites, and the parameter λ to the fa- cility opening cost. The uncapacitated facility-location problem is NP-hard for general graphs so we adopt a greedy approach presented in Algorithm 1. Assuming that each person has c can- didate mothers and fathers, the time complexity of this algorithm is O(cid:0)c2V + V log V (cid:1), which shows that it scales well in the number of people to be linked. The input probabilities p are com- puted with BinClass. Note that the facility assignment costs, that are based on the probabilities, are not necessarily a metric, so the approximation guarantees for methods, such as [16], do not neces- sarily hold in our problem setting. This method is called Collective. It outputs a genealogical net- work, where some of the links inferred by BinClass have been rewired in order to reduce the number of spouses. A limitation of Collective is that it does not recompute the link probabilities (the marginal distributions of the random variables x, indicating the parents). One approach for computing the marginal distribu- tions would be to adopt a Markov chain Monte Carlo (MCMC) method, which samples genealogical networks by proposing swaps to the parent assignments. However, to obtain a meaningful level of precision for the link probability estimates we need to sample a very large number genealogical networks, which renders such an MCMC approach non-scalable. Thus, in this work, we are not experimenting with link-probability estimation for Collective. Anders TihoinJohan TihoinCatharina TihoinCatharina TihoinAnna Helena TihoinJohan TihoinAnders TihoinLisa AiraxinMaria AiraxinElisabeth AiraxinMaria AiraxinenMaria HyvärinenMaria Airaxin Algorithm 1 A greedy method for collective genealogical network inference. Input: Child nodes V , parent candidates Cm, Cf and their prob- abilities p, parameter λ. Output: Inferred parent–child links R. log p(cid:0)Fa = f γ(cid:1) in a descending order. ∈ V by maxm,f log p(cid:0)Ma = m γ(cid:1) + ▷ Set of used mother–father pairs. ▷ Maximum probability. ▷ Best mother. ▷ Best father. pm,f = log p(cid:0)Ma = m γ(cid:1) + log p(cid:0)Fa = f γ(cid:1) a do 1: R = ∅ 2: Q = ∅ 3: Sort children a 4: for a ∈ V do pmax = −1 5: mmax = −1 6: fmax = −1 7: for (m, f ) ∈ Cm 8: 9: 10: 11: 12: 13: 14: 15: 16: 17: 18: return R a × Cf if (m, f ) (cid:60) Q then pm,f = pm,f − λ if pm,f > pmax then pmax = pm,f mmax = m fmax = f R = R ∪ (mmax, a) ∪ (fmax, a) Q = Q ∪ (mmax, fmax) Table 1: Accuracy of the links inferred with different meth- ods. Method Accuracy 12.5% 56.9% RandomCand NaiveBayes BinClass Collective 61.6% 65.1% 4 EXPERIMENTAL EVALUATION Next, we compare the proposed methods, BinClass and Collec- tive, to two baseline methods, NaiveBayes [24] and RandomCand, the latter of which randomly assigns the parents among the set of candidates. The methods are evaluated by computing their link accuracy which is the fraction of ground-truth child–parent links correctly inferred by the method. To use Collective, we first need to optimize λ-the penalty induced by each extra parent pair. The optimization is done using the training ground-truth data and the results are shown in Figure 3a. The training accuracy is maximized when λ = 1.6. The results for all methods are presented in Table 1. BinClass clearly outperforms the two baseline methods, and Collective further improves the accuracy of BinClass from 61.6% to 65.1%. To evaluate the accuracy of the link probabilities estimated by BinClass, we bin the probabilities and compute accuracy within each bin. The results presented in Figure 3b show that the estimated link probabilities are somewhat pessimistic, but overall, they are well in line with the link accuracies. Therefore, we can use the link probabilities to filter out links below a desired certainty level when analyzing the inferred network, as done in the next section. This filtering improves the precision of the inferred network but naturally also decreases the recall as illustrated in Figure 3c. In total, BinClass finds 1.8 million child–mother links and 2.5 million child– father links. If we require a minimum link probability of 90%, as done in the next section, we are still left with 253 814 child–mother links and 341 010 child–father links. 5 CASE STUDY: ASSORTATIVE MATING Assortative mating, also known as social homogamy, refers to the phenomenon that people tend to marry spouses with a similar socioeconomic status and it is one instance of social stratification. A recent study shows that assortative mating contributes to income inequality and it has been on the rise between 1960 and 2005 [14]. In this section, we leverage the inferred genealogical network to address two questions: (i) Can we detect assortative mating in historical Finland? (ii) How has the intensity of assortative mating evolved in his- torical Finland? 5.1 Estimating Social Status To detect assortative mating, we compare the socioeconomic status of the spouses inferred by our linking method. We use occupation as a proxy for status, and rather than comparing the occupations of the spouses directly, we compare the occupations of the spouses' fathers. The father occupations are more comparable since occupations were strongly gendered in the 18th and 19th centuries, which are the focus of this study. Furthermore, there is a separate field for father occupation in the birth records so we do not need to separately infer the fathers but only the spouses. The numerous variants and alternative abbreviations of the same occupation pose a challenge when comparing occupations. For in- stance, farmer, which is the most common occupation in the dataset, goes by the following (non-comprehensive) list of titles: bonden, bd., b., bd:, b:, b:n, bdn, b:den, talollinen, talonpoika, tal., talp., tl., tln., talonp. To address this challenge, we normalize the occupation titles by first removing special characters and then comparing the title to lists of abbreviations available online [1, 15]. We have also manually normalized the most common abbreviations not found in the online lists to increase the coverage of the normalization. In total, we are able to normalize 77.5% of all non-empty father occupation titles found in the birth records. In addition to comparing the normalized occupations directly, we also map them to the historical international classification of occupations (HISCO) [29]. Then we divide the HISCO classes into four main classes: (1) upper and middle class, (2) peasants (who own land), (3) crofters (who rent land), and (4) labourers (who live at another person's house). The class to which the father of a person belongs to is called Class4. We also map the HISCO classes into an occupational stratification scale HISCAM [20].4 HISCAM is a real-valued number between 0 and 100 which measures the social interaction distance of people based on their occupations. The Class4 and HISCAM codes are obtained for 75.5% of the people. 5.2 Measuring Assortative Mating A high percentage of matching spouse father occupations (p) is a signal of assortative mating but this percentage might also be 4More specifically, we use the "U2: Male only, 1800–1938" scale. For more information on the different scales, see: http://www.camsis.stir.ac.uk/hiscam/ 5 (a) Optimizing parameter λ which controls the penalty induced by each extra parent pair in the Collective linking method. (b) The link-probability estimates by BinClass correlate strongly with the ac- curacy of the links binned by their prob- ability. (c) The number of inferred family links with the estimated link probability above a given threshold. Figure 3: Experimental results on genealogical network inference. affected by external factors such as the number of distinct occupa- tions people had at a given time in a given city or the availability of data from different cities at different time periods. To control for these external factors, we introduce a null model, which shuffles the spouses within a city and a time window of 20 years and then computes the percentage of matching occupations (pn). Then we measure assortative mating as the ratio of the two percentages (p/pn). This ratio measures how much more likely people marry someone with a similar social status compared to a null model where the marriages are randomized. Thus a ratio larger than one is a sign of assortative mating. The higher-level occupation categories Class4 can also be used to compute match percentages (q and qn) and their ratio q/qn. With the HISCAM scores, we compute the mean absolute difference of the scores for the spouses (δ) and for the null model (δn), instead of the percentages. The assortative mating measure, in this case, is defined as δn/δ, so that again, a ratio larger than one indicates assortative mating. 5.3 Data As the set of spouses to be analyzed, we use all pairs of people who have been inferred to be the mother and the father of the same child. Both parent links are required to have at least a 90% probability (this threshold is varied in Appendix A). We limit the analysis to the period with the most records from 1735 to 1885. Requiring both parents to have a sufficiently high link probability limits the number of spouses to 14 542 pairs. Out of these, the father occupation is known for both spouses in 6 402 pairs and Class4 and HISCAM in 3 128 pairs. Although these filtering steps significantly reduce the number of spouses, we are still left with a sufficiently large dataset to perform a longitudinal analysis on assortative mating. 5.4 Results The percentages of matching spouse father occupations over time and the corresponding assortative mating curve are shown on the top row of Figure 4. In order to highlight long-term trends, the curves show moving averages where a data point at year y uses the inferred spouses from years [y − 10, y + 10] (the effect of varying the delta value of 10 years is studied in Appendix A). The figure also shows the 95% bootstrap confidence intervals. The middle and the bottom rows show the corresponding curves for the occupations grouped into four main classes (Class4) and for the numerical HISCAM scores of the occupations, respectively. All three measures of assortative mating suggest that assortative mating did occur in Finland between years 1735 and 1885 since the assortative mating curves are fairly consistently above the baseline ratio of 1. The intensity of the phenomenon varies mainly between 1 and 1.5 but interestingly, there is no monotonically decreasing or increasing trend. Finally, we observe that the spouse similarity curves p, q and δ have very different shapes, whereas the three assortative mating curves are clearly correlated (the correlation coefficients are 0.69, 0.23, and 0.62 for pairs (p/pn vs. q/qn), (p/pn vs. δn/δ), and (q/qn vs. δn/δ), respectively). This suggests that the proposed measures of assortative mating, which account for a null model, measure the phenomenon robustly. 6 RELATED WORK Genealogical network inference, also known as population recon- struction [3], is one application of record linkage, which has been an active research area for many decades and was mentioned already in 1946 by Halbert L. Dunn [10]-interestingly, in the context of linking birth, marriage, and other vital records. Two decades later, Fellegi and Sunter published a widely cited paper on probabilistic record linkage [12]. This approach considers a vector of attribute similarities between two records to be matched and then computes the optimal decision rule (link vs. possible link vs. non-link), as- suming independent attributes. The BinClass method, proposed in this work, adopts a similar approach, however, employing a super- vised classifier, which has the advantage of capturing dependencies between variables. Record linkage has been mostly studied for other applications, but recently, with the rise in the number of indexed genealogical datasets, several studies have applied record linkage techniques for 6 01234λ0.600.610.620.63TrainaccuracyCollectiveBinClass0.00.20.40.60.81.0Estimatedlinkprobability0.00.20.40.60.81.0LinkaccuracyOptimalObserved0.00.20.40.60.81.0Linkprobabilitythreshold0500,0001,000,0001,500,0002,000,0002,500,000NumberoflinksFathersMothers Figure 4: Assortative mating is detected in the inferred genealogical networks for Finland (1735–1885), but the phenomenon is not monotonously decreasing or increasing. Shaded areas correspond to the 95% bootstrap confidence intervals. genealogical data [7, 8, 11, 18, 19, 23, 25, 27]. The most closely re- lated to our work are the papers by Efremova et al. [11], Christen [7], and Kouki et al. [19]. Efremova et al. [11] consider the problem of linking records from multiple genealogical datasets. They cast the linking problem into supervised binary classification tasks, similar to this work, and find name popularity, geographical distance, and co-reference information to be important features. In our approach, we can avoid having to explicitly model name popularity, since the probability of a candidate parent is normalized over the set of all candidate parents, and for popular names this set will be large, thus downweighting the probability of the candidate. Christen [7] and Kouki et al. [19] propose collective methods for linking vital records. The former method is evaluated on historical Scottish data and it is concluded that due many intrinsically diffi- cult linking cases, the results are inferior to a linkage constructed by a domain expert. The latter method is evaluated on a more re- cent dataset collected by the National Institutes of Health and it 7 175017751800182518501875Year102030%ofmatching:OccupationsActualspouses(p)Nullmodel(pn)175017751800182518501875Year1.01.52.02.53.0Assortativematingp/pnBaseline175017751800182518501875Year406080100%ofmatching:Class4Actualspouses(q)Nullmodel(qn)175017751800182518501875Year1.01.52.02.53.0Assortativematingq/qnBaseline175017751800182518501875Year0246Absolutedifference:HISCAMActualspouses(δ)Nullmodel(δn)175017751800182518501875Year1.01.52.02.53.0Assortativematingδn/δBaseline yields a high linking F-measure of 0.946. This method is based on probabilistic soft logic (PSL), which makes it possible to add new relational rules to the model without having to update the inference method. In comparison to these works, we evaluate our methods on a dataset that is two orders of magnitude larger, and we show that the proposed BinClass method not only provides accurate matches but also reliably quantifies the certainty of the matches-an important feature of a practical entity-resolution system. Assortative mating,5 also known as social homogamy, has been studied widely in the sociology literature. The phenomenon has a significant societal impact since it has been shown to be connected to income inequality [14]. Greenwood et. al. [14] also find that assortative mating has been on the rise 1960–2005. Bull [5] studies assortative mating in Norway, 1750–1900, focusing on farmers and farm workers. They find that assortative mating was declining in the mid-1700s but after that it stayed fairly constant. This finding is largely in line with our results for Finland from the same time period. To control for the variations in the sizes of the groups, Bull computes odds ratios [5, 17], whereas we use a null model, which randomizes spouses. 7 DISCUSSION AND CONCLUSIONS We presented a principled probabilistic machine-learning approach, BinClass, for inferring genealogical networks. This approach was applied to a dataset of 5.0 million birth records and 3.3 million death records based on which it inferred a network, containing 13 genera- tions and a connected component of 2.6 million individuals, taking about one hour when parallelized over 50 machines. A comparison against a large human-compiled network yielded a link accuracy of 61.6%, outperforming a naive Bayes baseline method. We showed that the accuracy can be further improved to 65.1% by a collective approach called Collective. A key feature of BinClass is that it outputs probabilities for the inferred links. This allowed us to separate links that have a suffi- ciently high probability and to perform an analysis on the mating patterns observed in the network. The main findings of the analysis are that: (i) assortative mating-the tendency to select a spouse with a similar socioeconomic status-did occur in Finland, 1735– 1885, and (ii) assortative mating did not monotonically decrease nor increase during this time period. Limitations and future work. There is always uncertainty in- volved when analyzing records that are several centuries old and even an experienced domain expert can make incorrect linking decisions. Since our method relies on human-generated training data, any mistakes or biases in the training dataset affect the result- ing model and potentially the downstream analyses. Although the automatic approach enables data generation for various analyses at an unprecedented scale, one has to be careful when drawing conclusions. For instance, an interesting phenomenon that could be studied with the inferred networks would be long-term human mobility patterns. However, since the model uses features that are based on location, any potential biases learned by the model would directly affect the analysis of the resulting mobility patterns. 5Assortative mating can also refer to genetic assortative mating, but here we use it exclusively to refer to sociological assortative mating. 8 Many exciting future directions are left unexplored. First, it would be useful to extend the problem formulation so that it tries to jointly link all available record types, as now we only link birth records, using some features based on death records linked to the births separately. Second, it would be interesting to incorporate additional collective terms to the optimization problem, capturing patterns such as namesaking (a practice to name a child after an ancestor) or constraints on the family relations between individuals, which could be obtained from DNA tests. Third, there are many options for extending the assortative mating analysis presented in this work. We could study the differences in the strength of this phenomenon between social classes and between, for example, the first and the latter children. We could also extend the analysis to a related phenomenon of social mobility, which considers the status differences between parents and children instead of spouses. Fourth, with the advent of improved handwritten text recognition methods, similar historical birth record datasets can be expected to become available for many other countries. This will enable studying the generalizability of the proposed methods and the assortative mating analysis beyond Finland. Finally, the presented inference and analysis methods could be applied to other types of genealogical networks such as the genealogical networks of Web content [2]. To facilitate future research on these and other related research problems, the data and the code used in this paper have been made available at: https://github.com/ekQ/genealogy. ACKNOWLEDGMENTS We would like to thank the Genealogical Society of Finland for pro- viding the population-record data, Pekka Valta for the ground-truth data, and Antti Häkkinen for the HISCO and Class4 mappings. We are also grateful for useful discussions with Przemyslaw Grabowicz, Sami Liedes, Jari Saramäki, Ingmar Weber, and Emilio Zagheni. We also acknowledge the computational resources provided by the Aalto Science-IT project. Eric Malmi and Aristides Gionis were supported by the EC H2020 RIA project "SoBigData" (654024). A ASSORTATIVE MATING SENSITIVITY ANALYSIS In this section, we study the effect of varying the minimum link probability threshold (pth) of 90% and the moving average delta (∆t) of 10 years used in the analysis of assortative mating in Section 5. In the interest of space, we consider only the first assortative mating measure p/pN , which is based on the normalized occupations. The results are shown in Figure 5. First, we note that the larger the threshold pth or the smaller the smoothing parameter ∆t, the less data points we have per year and thus larger the confidence intervals. Second, varying the thresh- old does not seem to affect the p/pN curves significantly. Third, decreasing the smoothing parameter to ∆t = 3 makes the curves considerably less smooth, which suggests that a higher smoothing parameter might highlight the long-term trends more effectively. We conclude that these results support the findings that assorta- tive mating did occur in Finland, 1735–1885, but it did not mono- tonically decrease nor increase during this time period. Figure 5: A sensitivity analysis showing the effect of varying the minimum link probability threshold (pth) and the moving average delta (∆t) on the assortative mating curves from Figure 4 (top row). REFERENCES [1] 2016. Lyhenteitä (Abbreviations). http://www.saunalahti.fi/hirvela/historismi_ sivut/termitnew.html. (2016). Accessed: 2017-10-25. [2] Ricardo Baeza-Yates, Álvaro Pereira, and Nivio Ziviani. 2008. Genealogical trees on the Web: a search engine user perspective. In Proc. WWW. [3] Gerrit Bloothooft, Peter Christen, Kees Mandemakers, and Marijn Schraagen. 2015. Population Reconstruction. Springer. 9 [4] Glenn W Brier. 1950. Verification of forecasts expressed in terms of probability. Monthey Weather Review 78, 1 (1950), 1–3. [5] Hans Henrik Bull. 2005. Deciding whom to marry in a rural two-class society: Social homogamy and constraints in the marriage market in Rendalen, Norway, 1750–1900. International review of social History 50, S13 (2005), 43–63. [6] Tianqi Chen and Carlos Guestrin. 2016. XGBoost: A scalable tree boosting system. In Proc. KDD. [7] P. Christen. 2016. Application of advanced record linkage techniques for complex population reconstruction. ArXiv e-prints (Dec. 2016). arXiv:cs.DB/1612.04286 17501800185010203040%match.:Occ.pth=0.80,∆t=10ppn175018001850102030%match.:Occ.pth=0.90,∆t=10ppn175018001850102030%match.:Occ.pth=0.95,∆t=10ppn175018001850123p/pn175018001850123p/pn175018001850123p/pn1750180018502040%match.:Occ.pth=0.80,∆t=3ppn17501800185002040%match.:Occ.pth=0.90,∆t=3ppn17501800185002040%match.:Occ.pth=0.95,∆t=3ppn175018001850123p/pn175018001850123p/pn175018001850123p/pn [20] Paul S Lambert, Richard L Zijdeman, Marco HD Van Leeuwen, Ineke Maas, and Kenneth Prandy. 2013. The construction of HISCAM: A stratification scale based on social interactions for historical comparative research. Historical Methods: A Journal of Quantitative and Interdisciplinary History 46, 2 (2013), 77–89. [21] David Lazer, Alex Sandy Pentland, Lada Adamic, Sinan Aral, Albert Laszlo Barabasi, Devon Brewer, Nicholas Christakis, Noshir Contractor, James Fowler, Myron Gutmann, et al. 2009. Life in the network: the coming age of computational social science. Science 323, 5915 (2009), 721–723. [22] Jianxun Lian and Xing Xie. 2016. Cross-device user matching based on massive browse logs: The runner-up solution for the 2016 CIKM Cup. [23] Eric Malmi, Sanjay Chawla, and Aristides Gionis. 2017. Lagrangian relaxations for multiple network alignment. Data Mining and Knowledge Discovery (2017), 1–28. [24] Eric Malmi, Marko Rasa, and Aristides Gionis. 2017. AncestryAI: A tool for exploring computationally inferred family trees. In Proc. WWW Companion. [25] Eric Malmi, Evimaria Terzi, and Aristides Gionis. 2017. Active Network Align- ment: A Matching-Based Approach. In Proc. CIKM. [26] Alexandru Niculescu-Mizil and Rich Caruana. 2005. Predicting good probabilities with supervised learning. In Proc. ICML. [27] Bijan Ranjbar-Sahraei, Julia Efremova, Hossein Rahmani, Toon Calders, Karl Tuyls, and Gerhard Weiss. 2015. HiDER: Query-driven entity resolution for historical data. In Proc. ECML PKDD. [28] Yi Tay, Cong-Minh Phan, and Tuan-Anh Nguyen Pham. 2016. Cross device match- ing for online advertising with neural feature ensembles: First place solution at CIKM Cup 2016. [29] Marco HD Van Leeuwen, Ineke Maas, and Andrew Miles. 2002. HISCO: Historical international standard classification of occupations. Leuven University Press. [30] Ingmar Weber and Bogdan State. 2017. Digital Demography. In Proc. WWW Companion. [8] Peter Christen, Dinusha Vatsalan, and Zhichun Fu. 2015. Advanced record linkage methods and privacy aspects for population reconstruction-A survey and case studies. In Population Reconstruction. Springer, 87–110. [9] Kyle Cranmer, Juan Pavez, and Gilles Louppe. 2016. Approximating likelihood ratios with calibrated discriminative classifiers. ArXiv e-prints (March 2016). arXiv:stat.AP/1506.02169 [10] Halbert L Dunn. 1946. Record linkage. American Journal of Public Health and the Nations Health 36, 12 (1946), 1412–1416. [11] Julia Efremova, Bijan Ranjbar-Sahraei, Hossein Rahmani, Frans A Oliehoek, Toon Calders, Karl Tuyls, and Gerhard Weiss. 2015. Multi-source entity resolution for genealogical data. In Population Reconstruction. Springer, 129–154. [12] Ivan P Fellegi and Alan B Sunter. 1969. A theory for record linkage. AmerStatAssoc 64, 328 (1969), 1183–1210. [13] Angelos P Giotis, Giorgos Sfikas, Basilis Gatos, and Christophoros Nikou. 2017. A survey of document image word spotting techniques. Pattern Recognition 68 (2017), 310–332. [14] Jeremy Greenwood, Nezih Guner, Georgi Kocharkov, and Cezar Santos. 2014. Marry your like: Assortative mating and income inequality. The American Eco- nomic Review 104, 5 (2014), 348–353. [15] Aija Greus and Harri Hirvelä. 2016. Ammatit (Occupations). http://www. saunalahti.fi/hirvela/historismi_sivut/ammatit%20a-k.html. (2016). Accessed: 2017-10-25. [16] Kamal Jain and Vijay V Vazirani. 2001. Approximation algorithms for metric facil- ity location and k-median problems using the primal-dual schema and Lagrangian relaxation. Journal of the ACM (JACM) 48, 2 (2001), 274–296. [17] Matthijs Kalmijn. 1998. Intermarriage and homogamy: Causes, patterns, trends. Annual review of sociology 24, 1 (1998), 395–421. [18] Pigi Kouki, Christopher Marcum, Laura Koehly, and Lise Getoor. 2016. Entity resolution in familial networks. In Proc. MLG. [19] Pigi Kouki, Jay Pujara, Christopher Marcum, Laura Koehly, and Lise Getoor. 2017. Collective Entity Resolution in Familial Networks. In Proc. ICDM. 10
1801.01715
1
1801
2018-01-05T11:11:20
Spectral Graph Forge: Graph Generation Targeting Modularity
[ "cs.SI", "physics.soc-ph" ]
Community structure is an important property that captures inhomogeneities common in large networks, and modularity is one of the most widely used metrics for such community structure. In this paper, we introduce a principled methodology, the Spectral Graph Forge, for generating random graphs that preserves community structure from a real network of interest, in terms of modularity. Our approach leverages the fact that the spectral structure of matrix representations of a graph encodes global information about community structure. The Spectral Graph Forge uses a low-rank approximation of the modularity matrix to generate synthetic graphs that match a target modularity within user-selectable degree of accuracy, while allowing other aspects of structure to vary. We show that the Spectral Graph Forge outperforms state-of-the-art techniques in terms of accuracy in targeting the modularity and randomness of the realizations, while also preserving other local structural properties and node attributes. We discuss extensions of the Spectral Graph Forge to target other properties beyond modularity, and its applications to anonymization.
cs.SI
cs
Spectral Graph Forge: Graph Generation Targeting Modularity Luca Baldesi DISI Dept University of Trento [email protected] Carter T. Butts Sociology Dept Athina Markopoulou EECS Dept, CPCC University of California, Irvine University of California, Irvine [email protected] [email protected] 8 1 0 2 n a J 5 ] I S . s c [ 1 v 5 1 7 1 0 . 1 0 8 1 : v i X r a Abstract-Community structure is an important property that captures inhomogeneities common in large networks, and modularity is one of the most widely used metrics for such community structure. In this paper, we introduce a principled methodology, the Spectral Graph Forge, for generating random graphs that preserves community structure from a real network of interest, in terms of modularity. Our approach leverages the fact that the spectral structure of matrix representations of a graph encodes global information about community structure. The Spectral Graph Forge uses a low-rank approximation of the modularity matrix to generate synthetic graphs that match a target modularity within user-selectable degree of accuracy, while allowing other aspects of structure to vary. We show that the Spectral Graph Forge outperforms state-of-the-art techniques in terms of accuracy in targeting the modularity and randomness of the realizations, while also preserving other local structural properties and node attributes. We discuss extensions of the Spec- tral Graph Forge to target other properties beyond modularity, and its applications to anonymization. I. INTRODUCTION Generating random graphs with certain prescribed prop- erties is an increasingly important field [1], [2], [3], [4], [5]. Random graphs are widely used to model structure in social, computer, and biological systems, with applications ranging from importance sampling to the generation of syn- thetic data sets. One use of synthetic graphs is as a proxy of real-world data sets. For example, in the measurement community, researchers collect Internet [6], [7] or online social network [8], [9] topologies, making them available to other researchers for use in studying their properties or evaluating the performance of graph algorithms. In this context, it is often desirable to not release the original graph itself, but to generate synthetic graphs that (exactly or approximately) specify properties of interest of the real (or "target") graph, while varying with respect to other properties. This can be useful for anonymization purposes (i.e., to obfuscate individual or other sensitive information) and/or for simulation purposes (i.e., to ensure acceptable performance over a range of network structures, while preserving features known to be present in real-world use cases). This work was conducted when Luca Baldesi visited UC Irvine in 2016. All authors were partially supported by NSF Award III-1526736. A. Markopoulou is a member of the Center for Pervasive Communications and Computing (CPCC). Prior work has primarily focused on generating synthetic graphs with certain local structural properties, such as degree distribution, degree correlations, subgraph counts etc. [1], [3], [4], [5], [10], while global properties have received less attention. In this paper, we are interested in an important global property exhibited by many social and communications networks, namely community structure, which captures the complex pattern of inhomogeneities that characterize them. Real-world networks are typically irregular, containing nu- merous and often nested or overlapping subsets of vertices that are internally cohesive while being less well-connected to other subsets. This community [11] or cohesive subgroup structure [12] has a profound impact on phenomena such as diffusion or robustness to failure; it can also affect the performance of sparse-graph algorithms for tasks such as path or cycle counting that are sensitive to the presence of small, densely connected clusters of vertices. Graph generation methods that focus on local features (such as subgraph counts, the degree distribution, clustering etc.) do not necessarily preserve community structure, and the resulting graphs may be poor proxies for real-world networks in applications that are sensitive to it, such as diffusion. Therefore, distinct methods are needed to target it. In this paper, we present a novel random graph generation framework that is well-suited to the above applications. In par- ticular, we target community structure, within desired accuracy while allowing other features to vary. We use modularity, a well-known property of matrices to capture the community structure [11]. Starting from a given real graph as input, we use the original graph's high-level structure captured by the eigenstructure of its modularity matrix to derive a class of random graphs sharing the same modularity value, within a level of accuracy. Our approach can be summarized as follows and is depicted in Fig. 1. Given the adjacency matrix of a graph A, we capture its community structure via its modularity matrix (B). Because B is symmetric and real, it admits a spectral decomposition [13] which expresses the matrix in terms of a set of eigenvectors and eigenvalues. We apply a low-rank spectral approximation [14] on this eigenstructure to yield an approximated matrix reflecting the features most strongly associated with global structure; this matrix is then trans- formed and normalized to produce an edge probability matrix (A†), which is then passed to a sampling algorithm to yield a synthetic graph (with adjacency matrix A(cid:48)). The synthetic graphs produced will preserve the higher-order properties (modularity) of the input, while allowing other details to vary. Spectral Graph Forge has several strengths. First, our ap- proach is principled, based on spectral approximation of matrices, thus the name Spectral Graph Forge (SGF), and provides a tunable parameter to tradeoff between accuracy of the targeted modularity and the randomness of the produced realizations. Second, Spectral Graph Forge outperforms state- of-the-art baseline approaches in several aspects and for a range of graphs: (i) it achieves the target modularity more accurately than baselines (Section V-B) (ii) it preserves some metrics of local structure, beyond modularity (Section V-C) (iii) it can maintain the node and edge attributes, hence it can preserve properties beyond just pure topology (Section V-D). Third, the analysis of the entropy of graphs produced shows that they vary substantially on dimensions other than those deliberately targeted (Section V-E); we discuss how to exploit this property and use SGF as anonymization technique for social networks. Last but not least, SGF is not limited to targeting modularity, which is the focus of this paper. The general SGF framework can be used to target other matrix representations of a graph, such as the adjacency matrix or one of its derived matrices (including but not limited to modularity, laplacian, clique co-membership). The structure of the rest of the paper is as follows. In Section II, we review related work. In Section III, we dis- cuss community structure and its relation to modularity. In Section IV, we present our Spectral Graph Forge Frame- work, and how to apply it specifically to generate graphs with a prescribed modularity. In Section V, we evaluate our algorithms for various datasets (both synthetic and real-world social networks), against state-of-the art algorithms targeting modularity. Section VI concludes the paper. II. RELATED WORK There is a significant amount of work on generation of graphs that preserve local structural properties (e.g., degree distribution, small subgraph counts). Graphlets [5], motifs [4] and dK-series [1], [3] graph generators are all intended to produce graphs that preserve such properties, starting from an initial realization, or from a vector of input statistics. Exponential family random graph models (ERGMs) [15] can be employed to simulate graphs having the same expected values for a series of targeted features as the original, and most applications to date have likewise focused on local prop- erties (including properties that depend on nodal or edgewise covariates); among other differences from the above, ERGMs preserve only expected statistics (not exact values), but provide maximum entropy guarantees. In contrast, for global properties such as the graph mod- ularity [11], there exist only a few approaches so far that target them by design. Trajanovski et al. [16] propose an algorithm for generating graphs with a prescribed modularity. The Karrer and Newman stochastic block model [17] generates graphs with a given community structure and modularity value. In principle, other latent structure models such as the latent space models [18] and latent stochastic block models [19] could also be used to simulate graphs with related properties, although applications to date have been focused on infer- ence. In Section V-A2, we describe the modularity-targeting algorithms by Trajanovski et al. and Karrer and Newman, and we used them as baselines for comparison. The relation between modularity and eigenstructure has been investigated mainly for applications such as community detection [11], [20], visualization [21], and analysis [18]. To the best of our knowledge, our work is the first to design and implement a general framework for generation of synthetic graphs with specified high-level structure (modularity being the focus in this paper) by means of spectrally transformed inputs. III. MODULARITY AND COMMUNITY STRUCTURE A. Definitions and Intuition Modularity is one of the most widely used metrics for char- acterizing community structure [22]. It expresses the extent to which a partition of vertices divides the graph such that within- group densities are higher than between-group densities; the maximum modularity obtainable over all partitions is hence a global measure of the extent to which a graph approximates a union of dense structures that are minimally connected to one another. Modularity is closely related to cohesive subgroup structure, a topic of historical sociological interest [23], [24], and has been the object of extensive study within the large literature on community detection [22], [11], [20]. Formally, modularity is defined as follows. Given a graph G = (V, E), where V = n, with adjacency matrix A and degree vector K = (k1, . . . , kn), the modularity matrix B is defined as [11] where K = (cid:80)n Bij = Ai,j − kikj K i=1 ki is the degree sum. B effectively captures the number of edges within nodes of the same com- munity compared to a random graph with the same expected degree sequence. Given a node partition {C1, . . . , Cm} with nodes assigned to communties c1, . . . , cn ∈ {C1, . . . , Cm}, the modularity value measuring this concentration over all node pairs is: (1) (cid:18) (cid:88) (cid:19) Q = 1 K i,j Ai,j − kikj K δ(ci, cj). (2) where δ(a, b) = 1 iff a = b and 0 otherwise. The notion of modularity is used in three ways. First, given a partition of nodes into communities c1, . . . , cn, Q provides a metric for how well the partitioning matches the actual topology. Second, Q can be used to search for community structure, by seeking a partition of nodes into m∗ communities, c∗ n, such that Q∗ is maximized. Finally, the maximized value of Q∗ over all partitions can be taken as an indicator of the extent to which the graph naturally divides into distinct communities. This quantity is sometimes referred to generically as the modularity of the graph. 1, . . . , c∗ B. Modularity and Spectral Structure The eigenstructure of an adjacency matrix A associated to a given graph is intimately related to the structure of the associated graph. A can be decomposed in a set of eigenvalues λi and eigenvectors vi; the eigenvectors associated with pos- itive eigenvalues describe core-periphery structures [25] and the signs of their entries describe possible graph bi-partitions. The eigenvectors associated with negative eigenvalues relate instead to memberships in bi-partitions, so that, the sign of their entries indicate a likelihood of node connection. Hence, there is an obvious affinity between the information described by the eigenvectors and modularity but for the leading eigenvector, associated to the main core of the network (the whole graph) and it would be natural to consider the eigenstructure of the residual matrix A−λ1v1vT 1 (where λ1, v1 are respectively the leading eigenvalue and eigenvector) as a basis for community detection. hence the modularity matrix B = A −(cid:0)KK T(cid:1) /K is very However, in practice, v1 is typically correlated with K, and close to the residual matrix. In keeping with this observation, it is common practice (e.g., [11]) to work with the eigenstructure of B to identify partitions, recursively subdividing nodes into classes based on the signs of their eigenvector elements associated with high-modulus, positive eigenvalues of B. For example, in [22], Newman showed that the leading eigenvector of the modularity matrix B determines the best bipartition of nodes into two communities. Beyond modularity: While in this paper, we focus on targeting modularity, our spectral decomposition framework is more general and can be tuned to capture desired structural el- ements of interest, while randomizing out other features. More generally, we could also apply SGF to matrices other than B (namely A and its derived matrices), and use it to target other global properties. For example, while the leading eigenvector defines the best bipartition [22], positive/negative eigenvalues capture core-periphery/bipartition structures, respectively. IV. SPECTRAL GRAPH FORGE The Spectral Graph Forge takes an undirected graph G with n nodes as input and, for each run, produces a random output graph G(cid:48) with the same number of nodes. We represent G and G(cid:48) with their respective adjacency matrices A, A(cid:48) ∈ {0, 1}n×n. The Spectral Graph Forge is designed to be as modular and extensible as possible; its graph construction process can be viewed, hence, as a pipeline composed by several nearly independent steps, each of which can be varied as needed by the user. A representation of this pipeline is depicted in Fig. 1. A. Transformation To allow the Spectral Graph Forge to preserve structure associated with either A or a derived matrix, we work with a user-selected real-valued, symmetry preserving transformation of A, denoted M. The main use case of M in this paper is the modularity matrix M = B = A −(cid:0)KK T(cid:1) /K. Other examples of M include the adjacency matrix itself M = A, A Transformation M = A M =A − KKT K Sampling (cid:48) A = Bernoulli(A†) Back- Transform. A = M A = M + KKT K low-rank α- approximation of M → M Normalizing A† = logistic( A, k) A† = truncate( A) A† = scale( A) A(cid:48) Fig. 1. The pipeline of the Spectral Graph Forge (SGF) Framework. Given an (cid:48) undirected graph adjacency matrix A as input, SGF outputs a "similar" one A from which we can build the corresponding graph, called SGF(α). Sub-blocks indicate mutually exclusive options for each step. The focus of this paper is on using SGF to target modularity, by setting M = B = A−(cid:0)KKT(cid:1) /K), and the corresponding blocks are highlighted in grey. and the clique co-membership matrix (whose i, j cells are the counts of cliques containing both i and j). B. Low-rank α approximation. Since M is real and symmetric, it can be expressed as M = V ΛV T = λivivT i , (3) n(cid:88) i=1 where λi, vi are respectively the ith eigenvalue and the ith eigenvector of M (all of which are real). W.l.o.g., we scale vi so that vi2 = 1 and sort the eigenvectors/eigenvalues such that λ1 ≥ ··· ≥ λn. Hence the first components of Eq. (3) contribute to M more than the last ones. We can perform a lossy compression of M by removing the least important frequencies. We use a parameter α ∈ [0, 1] to control the fraction of the eigenvectors we want to keep from the original M and our approximation is M = λivivT i (4) (cid:100)αn(cid:101)(cid:88) i=1 This is essentially a low-pass filter on M, which retains global characteristics captured by the first αn eigenvectors of the matrix, while removing the remaining ones, associated with idiosyncratic local structures.1 The euclidean norm of the error, M − M, due to transformation can be computed as (cid:13)(cid:13)(cid:13)M − M (cid:13)(cid:13)(cid:13)2 = (cid:13)(cid:13)(cid:13)(cid:13)(cid:13)(cid:13) n(cid:88) i=(cid:100)αn(cid:101)+1 (cid:13)(cid:13)(cid:13)(cid:13)(cid:13)(cid:13)2 λivivT i = λ(cid:100)αn(cid:101)+1 (5) 1We could also filter on phase (a graph polarizing filter) to extract core- periphery (positive eigenvalues) or bipartite (negative eigenvalues) structures. Hence, SGF can target the reproduction of M within arbitrary precision, by tuning α (see Appendix A). C. Back-Transfomation. Once the low-rank approximation M is obtained, we need to transform it to obtain an approximated adjacency matrix A ∈ Rn×n. Where the back-transformation is the inverse of the transformation M to M. For the modularity matrix M = B = A −(cid:0)KK T(cid:1) /K, the back transformation is intuitive: A = M +(cid:0)KK T(cid:1) /K. Other choices of back-transformation may be employed where M is not invertible (e.g., in the case of the co-clique matrix), resulting in a different approximation. Since A is not, in general, an adjacency matrix, our SGF fills the gap between A and the final A(cid:48), by normalizing the values to be within [0, 1] (A†) and by using a stochastic process that forces the elements to be either 1 or 0 (A(cid:48)), as described next. D. Normalization We first normalize the values of the latter in [0, 1] obtaining: † i,j = norm( Ai,j), where norm is a user-specified normaliza- A tion function. With modularity in mind, we investigated three variants for this normalization function: • logistic( Ai,j, k) = 1+e(0.5− Ai,j )·k , where k ∈ [2, 10] 1  1 0 Ai,j if Ai,j ≥ 1 if Ai,j ≤ 0 otherwise • truncate( Ai,j) = • scale( Ai,j) = Ai,j−mins,t As,t maxs,t As,t−mins,t As,t where k ∈ [2, 10] is a parameter we use to tune the inclination of the logistic() function. We have extensively evaluated the above normalization functions and we found that the truncation rule gives the clean- est entropy and distance relationships; in fact, scale introduces a distortion highly dependent on the difference between the minimum and maximum value while logistic (for which we found with k = 6 provides the best performance for our case of study) shows poor sensitivity to α, preserving relatively little structure throughout. Details on this investigation are deferred to Appendix B. E. Sampling Taking A† as a matrix of expectations for A(cid:48), we complete our process by drawing A(cid:48) from an inhomogeneous Bernoulli † i,j), ∀j > i. Note that graph distribution: A(cid:48) to generate a simple undirected graph A(cid:48), we set: i,j = bernoulli(A • A(cid:48) • A(cid:48) i,i = 0, ∀1 ≤ i ≤ n i,j, ∀j > i j,i = A(cid:48) As with other aspects of the pipeline, this can be generalized (e.g., to allow for degree or other constraints). In the following, we denote by SGF(α) as the graph resulting from A(cid:48), drawn using our method on fraction α of the eigenvectors. Entropy of the Synthetic Graphs. One advantage of the use of an inhomogeneous Bernoulli graph in our pipeline is that we can compute exactly the (Shannon) entropy of our synthetic distribution. Entropy indicates the degree of variation in the output graphs, and is an indicator of the extent to which a graph generation method is able to provide a range of structures compatible with its arguments; at constant graph order n, it necessarily varies between n(n − 1)/2 bits for a uniform random graph and 0 bits for a generator that produces only a single realization with certainty. Given a fixed level of preservation of targeted features, generators with higher entropy are typically preferable (as they vary the distribution of structures as widely as possible, given the desired constraints). The ability to easily compute output entropy is a useful feature of our approach; by contrast, most other approaches provide no known way of computing output entropy, making it difficult to assess the extent to which they are able to produce a diverse range of structures. Since A(cid:48) is drawn from a Bernoulli graph distribution with parameter matrix A†, the entropy is immediate: n(cid:88) readily computed from A†, where S = (cid:80) (log2 δ + log2(1− δ)) is the normalization factor and † i,j is the expected graph density under A†. δ = 2 This index can be interpreted as the fraction of the maximum possible entropy that A(cid:48) attains, given its expected density. F. Computational Complexity i,j) log2[1− A i,j]− (1− A † † † i,j], −A † i,j log2[A which is n(cid:88) −n(n−1) † H(A i=1 j=i+1 n2−n i,j A ) = 1 S 2 To analyze the complexity of SGF, we consider the com- plexity of each block in Fig. 1. The pipeline starts with a V = n,E = m. The Transformation graph G = (V, E), and Back-Transformation blocks can clearly be performed in O(n2). The Normalizing and Sampling blocks operate element-wise on n × n matrices and apply a float operation so their cost is O(n2). The Low-rank α-approximation block performs a spectral decomposition on a n × n matrix which can be done in O(n3) or O(nm) in case of an input sparse matrix2. Overall, the bottleneck of SGF is the spectral de- composition, which, for sparse input matrices M, has hence a complexity of O(n2) [11]. We mainly target social graphs where the community structure analysis is of main interest; these graphs are generally quite sparse with a low number of nodes (each of the network in our real-world dataset has less then 105 nodes). Furthermore, SGF can gracefully tradeoff complexity for accuracy by tuning the parameter α: keeping a few eigenvectors in the approximation (Eq. (4)), increases the error (Eq. (5)) but decreases the complexity of the spectral decomposition (e.g. using the moment method). A. Evaluation Setup V. EVALUATION To validate our approach, we test the Spectral Graph Forge against state-of-the art baselines (Section V-A2) on several datasets (Section V-A1), and in terms of several metrics. 2Since M symmetric, we can find an orthogonal matrix Q such that the similarity transform T = QT AQ gives a tridiagonal matrix [11], which belongs to O(nm) with the Lanczos algorithm [26]. The eigenvectors vi = Qwi of M are hence directly computable from the eigenvectors wi of Q. Since Q is tridiagonal, its eigenvectors can be computed with the QL algorithm with a cost of O(n) [11]. 1) Datasets: We use both synthetic and real-world datasets; the former for a fair comparison on well-known state-of-the- art datasets in the field of community detection, and the latter to show that our results hold with real data as well. I. Synthetic Datasets. A random graph generator that controls modularity is the following: fix the number of com- munities and then control the intra-community vs. inter- com- munity probability of edge: fixing the inter-community edge probability, higher values of intra-community edge probability leads to higher modularity value. Although stylized, this model allows for explicit control of the inherent modularity of the synthetic graph. This idea has been widely used since the early days of community detection. For example, Girvan and Newman [27] generated graphs with 128 nodes, communities of the same size and essentially constant node degree. The idea has been extended by Lancichinetti et al. [28] to produce networks of 1000 nodes and geometrically distributed node degrees and community sizes. We use both generators to produce ten networks from each, and refer to them as Girvan or Lancichinetti datasets, respectively. II. Real World Datasets. In the real world, community structure can be found in nearly any network representing interpersonal relationships. Some of the most striking group structures are seen in the context of friendship networks, particularly for populations such as adolescents (who are fre- quently segregated by age, among other factors). The National Longitudinal Study of Adolescent to Adult Health (referred to as Add-Health in the following) is a U.S. national study on adolescents in grades 7-12. It is a large, longitudinal study of students drawn from a sample of American secondary schools, with data being collected during an initial in-school survey followed by four in-home interviews spanning from 1994 to 2008 [29]. In this work we employ the public-use network data from the first wave, in which students were asked to nominate peers they considered to be friends; the data used here comprises 16 different networks, in which each network represents a school (or pair of linked schools in which graduates of the first proceed to the second), each vertex represents a student, and each edge represents a friendship nomination. For each student, we are also provided with data on gender, race/ethnicity, and grade. Overall, friendships are strongly segmented by grade, with additional divisions by other demographic characteristics in most schools. Finally, we also consider smaller networks frequently en- countered when analyzing large-scale network data. Given a large network and a given node, an egocentric network (or ego net) for this node is the induced subgraph formed by the node ("ego") and its first-order neighborhood ("alters"). An ego net hence includes all ego-alter ties, together with the alter-alter relationships; cohesive subgroups in the ego net (with ego subtracted) thus mark the local communities of alters with whom ego interacts. Here, we employ the Facebook dataset of Mcauley and Leskovec [30], which contains a set of ego-networks derived from the Facebook social network comprising of 10 different networks of size ranging from 52 to 1034 nodes (ego removed for analysis). 2) Baseline Modularity-Targeting Algorithms: There are two classes of prior state-of-the-art graph generation algo- rithms that have been used to explicitly target modularity. We briefly present here these algorithms to facilitate better understanding of our experimental results. I. Trajanovski Algorithm Trajanovski et al. [16] present three different rewiring operations capable of varying the modularity value of a graph with a given partition. The input to the algorithm is a target modularity value Q∗ t , a number of communities m and a total number of links L. In the initialization phase, it creates the communities of nodes in the form of a tree with no more than one link between two communities. This configuration has the maximum achievable modularity for the given input. Then, rewiring transformations are applied to lower the modularity value to the target one. A limitation of this approach is that it assumes the commu- nity graph partitioning c∗ n never changes. Since the best partition is dictated by the topology, the rewiring process may alter them and, consequently, yield an apparent modularity that is lower than the optimum. Hence, even if the rewiring process successfully obtains the desired modularity value Q∗ t with respect to the initial partitioning, the output graph may have topology with a slightly different inner community structure, leading to a completely different modularity value Q∗ o. II. Degree Corrected - Stochastic Block Model (DC-SBM) The stochastic block model [31] is a generative algorithm for groups or communities in networks. The related algorithms work by placing each edge ei,j between the vertices vi, vj with a probability which is function of ci and cj. Since ci, cj ∈ {C1, . . . , Cm}, these probabilities form a matrix of inter and intra community (block) connection probabilities. 1, . . . , c∗ Generally, simple stochastic block models have difficulty in building graphs with community structure matching real-world data sets [17]. A limitation of the most basic models in this class is that they do not include effects for other forms of struc- ture found in real-world networks, e.g. degree heterogeneity. The approach proposed by Karrer and Newman [17] rectifies this last limitation by correcting for the degree distribution, yielding improved performance on realistic topologies. B. Results on Targeting Modularity Here, we evaluate the main objective of this paper, i.e., how well Spectral Graph Forge achieves the target modularity. When comparing the modularity value of an input graph Qi (or Q∗ i ) with the modularity value of an output one Qo (or Q∗ o), we consider the (maximum) modularity ratio Qo ): the Qi closer this ratio to 1, the closer the output graph matches the input in terms of modularity. To compute the modularity value we use the well-known algorithm by Lefebvre et al. [32].3 (or Q∗ Q∗ 1) Insights into SGF itself.: We first consider a trivial dataset for which our graphs are made of 128 nodes and 2 or 8 communities, and we vary parameters of SGF (α) as well as the inherent community structure of the target network to get o i 3There is a large body of work on community detection algorithms to n and the associated maximize Q [33]. In this work, we compute c∗ modularity values using the well-known algorithm by Lefebvre et al. [32]. 1, . . . , c∗ Fig. 2. Modularity ratio for Spectral Graph Forge varying α on our simple graphs with 2 communities (upper plot) and 8 communities (lower plot). Fig. 3. Modularity ratio for Spectral Graph Forge on our simple graphs varying their connectivity with 2 communities. o i o i insights into the behavior of SGF. Fig. 2 shows the maximum modularity ratio Q∗ varying the α parameter with networks Q∗ of two and eight communities respectively. As expected, the as α → 1, the more eigenvectors are used and the better the performance ( Q∗ Q∗ → 1). The SGF performance, in terms of how well it targets mod- ularity, is also influenced by the inherent community structure. In Fig. 2, we see that SGF requires more eigenvectors for 8 than for 2 communities, in order to obtain similar results. In Fig. 3, we see that the higher the modularity of the input graph (controlled by the intra-community edge probability) the better the performance of SGF. 2) Evaluating SGF against baselines.: Experiments. In the SGF pipeline, we target the modularity matrix as the M = B, the truncation as the normalization function, and a value α = 0.9. We apply SGF to each input network ten different times, computing the modularity ratio for each simulation; the same process is carried out for the two baseline algorithms. In particular, for the Trajanovski et al. algorithm, we compute the modularity value Q∗ o, the number of nodes n, the number of edges and the number of communities from each input graph and we use them for the Trajanovski approach. As input Fig. 4. Means and 99% confidence intervals for the modularity ratio, by method and data set. MODULARITY RATIO FOR ALL THE STRATEGIES ON ALL THE DATASETS. TABLE I Strategy SGF(0.1) SGF(0.1) SGF(0.2) SGF(0.2) SGF(0.3) SGF(0.3) SGF(0.4) SGF(0.4) SGF(0.5) SGF(0.5) SGF(0.6) SGF(0.6) SGF(0.7) SGF(0.7) SGF(0.8) SGF(0.8) SGF(0.9) SGF(0.9) DC-SBM DC-SBM Trajanovski Trajanovski Dataset Add-Health Girvan Add-Health Girvan Add-Health Girvan Add-Health Girvan Add-Health Girvan Add-Health Girvan Add-Health Girvan Add-Health Girvan Add-Health Girvan Add-Health Girvan Add-Health Girvan Mean 0.76038 0.74602 0.71985 0.70728 0.75379 0.70690 0.80250 0.73735 0.82452 0.77007 0.86057 0.83302 0.88024 0.88050 0.93563 0.92902 1.02524 1.02722 0.88304 0.88989 0.71150 0.97946 Std 0.10479 0.01709 0.06740 0.01033 0.07496 0.01553 0.10278 0.00793 0.08711 0.01134 0.08472 0.01151 0.05368 0.01007 0.03820 0.00797 0.03708 0.00429 0.09229 0.00892 0.08293 0.31149 Dataset Facebook Lancichinetti Facebook Lancichinetti Facebook Lancichinetti Facebook Lancichinetti Facebook Lancichinetti Facebook Lancichinetti Facebook Lancichinetti Facebook Lancichinetti Facebook Lancichinetti Facebook Lancichinetti Facebook Lancichinetti Mean 0.80551 0.58268 0.82773 0.54349 0.87341 0.55989 0.86587 0.59954 0.89184 0.64635 0.91149 0.71476 0.93420 0.78831 0.96249 0.87126 0.98131 1.05135 0.89041 0.90944 1.38715 0.79338 Std 0.07143 0.00799 0.08925 0.00576 0.08013 0.00530 0.06847 0.00445 0.06929 0.00339 0.06688 0.00564 0.07223 0.00714 0.02018 0.00553 0.05789 0.00338 0.11375 0.00462 0.45120 0.00097 1, . . . , c∗ to the DC-SBM algorithm, instead, we use the node degree sequence, the node group assignment c∗ n, the group degree sequence on this partition and the number of edges between each pair of groups, computed on the original graph. Comparison. Table I reports the mean and the standard deviation of obtained modularity ratios comparing the methods with different values of α on every dataset and it shows the Spectral Graph Forge requires α ∼ 0.7, 0.8 in order to obtain results similar to the one of DC-SBM and that Trajanovski obtains results with a very high standard deviation from the target value. Fig. 4 reports the mean and 99% confidence intervals for the resulting modularity ratios, for which SGF with α = 0.9 consistently produces graphs with a maximum modularity nearly equal to the input data set (modularity ratio appx. 1). In contrast, the Trajanovski et al. algorithm frequently produces graphs with too high or too low modularity, and does so with high variance. The DC-SBM performs more consistently, but tends to achieve modularity lower than the target, and generally shows higher variance. Interestingly, both the Trajanovski et al. and DC- SBM algorithms perform better on the synthetic data sets than in their real-world counterparts. Across all four data sets, the Spectral Graph Forge is consistently closer to the target. Fig. 5 looks at a related but different metric: it presents means and 99% confidence intervals for the ratio of number 0.6 0.7 0.8 0.9 1Mod. ratioSGF 0.6 0.7 0.8 0.9 1 0 20 40 60 80 100 120Mod. ratioIncluded eigenvectors 0.75 0.8 0.85 0.9 0.95 1 1.05 0 0.2 0.4 0.6 0.8 1Mod. ratioSGF(0.1)SGF(0.5)SGF(0.9) 0.6 0.7 0.8 0.9 1 1.1 1.2 1.3 1.4 1.5 1.6Add-HealthFacebookGirvanLancichinettiModularity RatioTrajanovskiSGF(0.9)DC-SBM Fig. 5. Means and 99% confidence intervals for the partition number ratio, by data set. Note that the SGF(0.9) and DC-SBM algorithm results overlap with the Girvan data set graphs. Fig. 7. Means and 99% confidence intervals for degree sequence correla- tion, by data set. Note that the DC-SBM result lower bound overlaps the Trajanovski results with the Girvan dataset. since it targets global structure - it in fact does well for all four data sets. By contrast, the other modularity-targeting methods do not tend to preserve clustering. This is particularly evident for the Trajonovski et al. algorithm, whose rewiring strategy can easily alter the structure of triads. Degree sequence. We also examined the correlation of the degree sequence of the input and output graphs. (Recall that, in the presence of covariates, nodes are non-exchangeable.) While the eigenvectors of the modularity matrix are only loosely connected with degree, we show better performance on this metric than the competing methods. In particular, Trajanovski doesn't attempt to preserve the degree distribution at all, leading (reasonably enough) to a nearly complete loss of correlation between degree sequences. The relatively poor performance of the DC-SBM method is more surprising, given that it attempts to preserve degree information. Overall, it performs only slightly worse than the Spectral Graph Forge for three out of four data sets, the lone exception being the Girvan synthetic networks (where the Spectral Graph Forge has a correlation of nearly 1, vs. almost 0 for DC-SBM). D. Results on Attribute Modularity Preservation We find that our approach not only successfully preserves the maximum modularity value Q∗ but also preserves the modularity of significant partitions other than the topologically best one. If we consider partitions c1, . . . , cn indicating e.g. gender, race/ethnicity, or school grade provided by the Add- Health dataset, we can compute the resulting modularity values Qi, on the original graphs, and Qo on the output graphs after applying the same attribute sequence, summarizing the similarity by the resulting modularity ratio. The closer this ratio is to 1, the better maintained the community structure for partitions associated with important covariates (whether or not they correspond to modularity-maximizing partitions). Fig. 8 shows the comparison. The Add-Health dataset is a real-world dataset with attributes associated with the nodes. Attribute labeling for the output graphs of Trajanovski and DC-SBM is done trivially, by assigning attributes to the nodes in the same order as the input ones. As expected, the Spectral Graph Forge closely preserves modularity on all Fig. 6. Means and 99% confidence intervals for average clustering ratio, by data set. of detected output partitions (under modularity maximization) vs. the number of input partitions; this expresses the extent to which each algorithm preserves the number of communities found in the input graph. The target value is again 1, as our objective is to generate graphs with the same number of communities. Spectral Graph Forge consistently reproduces the number of input partitions for three out of the four data sets, but tends to split communities within AddHealth. None of the other algorithms consistently performs as well as the Spectral Graph Forge, with some being tied on some data sets; the only case of better performance by a competing algorithm is DC-SBM on AddHealth, which overproduces communities by a slightly smaller margin.4 C. Results on Other (Local) Structural Properties In addition to accurately targeting modularity, our approach also generates output graphs A(cid:48) = SGF (α) maintaining other important (local structural) properties of the input A. Clustering is a local network property, indicating the extent of triadic closure. Fig. 6 presents means and confidence intervals for the average clustering ratio between the output and input graphs. Although it is not apparent that the Spectral Graph Forge would do well at capturing this local property - 4 None of the three algorithms perform optimally on this data set. That can be due to input partition solutions not necessarily stable to small perturbations, and a generated graph could have different numbers of identified subgroups than the source graph even if the two are similar in most respects. 0 0.5 1 1.5 2 2.5 3 3.5Add-HealthFacebookGirvanLancichinettiNumber of Partitions RatioSGF(0.9)TrajanovskiDC-SBM 0.2 0.4 0.6 0.8 1 1.2 1.4 1.6 1.8 2Add-HealthFacebookGirvanLancichinettiAvg Clustering RatioTrajanovskiSGF(0.9)DC-SBM-0.2 0 0.2 0.4 0.6 0.8 1Add-HealthFacebookGirvanLancichinettiDegree CorrelationSGF(0.9)TrajanovskiDC-SBM Fig. 8. 99% confidence interval on attribute modularity ratio for the Add- Health dataset. attribute partitions, while the other methods typically perform poorly, entirely losing the graph structure. This is not sur- prising as the other methods were not designed to preserve other community structure but the topological one and their performance are shown only for completeness. On contrary, SGF successfully reproduce all the possible (even overlapping) community structures from the original ones, being, to the best of our knowledge, the first suitable generator for creating graph proxies with complex community structures. E. Randomness of Realizations and (De)anonymization The closer α is to 1, the better our approach targets the intended modularity. However, two natural questions arise from this relationship: (1) as α → 1, how concentrated is the distribution of graphs A(cid:48) = SGF (α) we produce? (2) as α → 1, how distinct is our output A(cid:48) from the input A? Ideally, we would like a relatively low level of concentration and a reasonable distance from the input graph, to grant a sufficient degree of randomness in our realizations. We use the normalized Shannon entropy to measure the concentration of the SGF distribution in the space of graphs; this is important for the use case of simulation. To measure the distinctness of a realized graph from the input network, we consider a pragmatic metric that maps to another important potential use case: resistance to de-anonymization attacks. We envision that Spectral Graph Forge could be used not only as a graph gen- erator for simulating graphs resembling real-world networks, but also as an anonymization technique (in conjunction with others) to anonymize A to A(cid:48), while preserving several global and local properties. De-anonymization attacks attempt to identify the nodes in a partially labeled graph, exploiting similarities between the two graphs and potentially auxiliary informartion. To the extent that a generated network cannot be readily de-anonymized with respect to the original graph structure, the two networks are clearly distinct; this is important for applications such as anonymization of real network datasets, where concealment of node identities is a major priority. For example, a Facebook dataset may be collected and made publicly available after Fig. 9. Means and 99% confidence intervals for graph distribution entropy and DV de-anonymization success rates on one Add-Health graph (upper plot) and one Facebook graph (lower plot), by α. proper anonymization (removing node ids, and perturbing the network structrure); de-anonymization attacks can infer the node ids based on graph structure and auxiliary infor- mation. A survey of state of the art anonymization and de- anonymization techniques can be found in [34]. We pick one of the state-of-the-art de-anonymization attacks: the Distance Vector attack [35], which is proven to be scalable, robust and exploitative of global graph characteristics [34] preserved by the SGF. At each run, we feed the Distance Vector attack with a seed of 5% of nodes as ground truth and we report the mean fraction of nodes the attack successfully identified. Examining the fraction of nodes identified as a function of α allows us to examine the tradeoff between privacy preservation and synthetic data quality. The upper plot of Fig. 9 presents the results for one connected graph from the Add-Health dataset. We note that the modularity ratio remains close to the target 1 even for low values of α, implying that it is possible to preserve much of the community structure with a fairly small fraction of eigenvectors. Entropy is close to 0 for very large α, but climbs steadily as α is reduced, indicating the extent of reduction in concentration. More striking is the success rate of the DV attack. Even at α = 0.9, the attack can identify only around 60% of nodes from the original graph given the synthetic graph and a 5% seed sample. This falls apace, with a success rate of only around 20% once α = 0.5 (corresponding to a modularity ratio ∼ 0.82 from Table I), and a rate not significantly different from baseline once α = 0.25 (modularity ratio ∈ (0.71, 0.75)). Given the strength of this attack, this implies a high degree of discrepancy between the initial and target graph (while maximum modularity is preserved). Similar results are reported in the lower plot of Fig. 9 for a connected graph from the Facebook dataset. Again, even for high values of α the de-anonymization attack cannot fully align the graphs. -1-0.5 0 0.5 1 1.5SexRaceGradeModularity RatioDC-SBMTrajanovskiSGF(0.9) 0 0.2 0.4 0.6 0.8 1Modularity RatioDV Success RatioNorm. Entropy 0 0.2 0.4 0.6 0.8 1 0 0.2 0.4 0.6 0.8 1α For both datasets, when α = 0.1, the modularity ratio is still close to the target 1 and the de-anonymization attack can identify only approximately 10% of nodes (while knowing 5% in the first place). This suggests that the SGF has the potential to be used as a tool (in combination with others [34]) for anonymizing sensitive graph datasets. VI. CONCLUSION We propose Spectral Graph Forge (SGF) - a framework for generating graphs that resemble real-world networks in terms of global properties, via spectral decomposition and approxi- mation. Our focus in this paper was the use of SGF specifically to generate graphs with a target modularity; we showed that it succeeds in doing so and it outperforms baselines. At the same time, SGF preserves other important local structure properties (such as clustering and the degree sequence) and node attribute structure. It also does well at preserving modularity associated with such node attributes, even when they are not specifically targeted; this allows SGF to generate reliable graph proxies for real-world networks with arbitrarily complex and overlapping community structures. The parameter α can control not only the error in modularity (α → 1 brings us arbitrarily close the target modularity) but also the entropy of graph distribution. Lowering α leads to higher entropy of the realizations, thus making the node identities in the input graph increasingly difficult to reveal via de-anonymization attacks. This makes SGF a potentially useful tool (in combination with existing anonymization techniques) for generating synthetic data sets from sensitive data. Our codebase is available on-line [36]. REFERENCES [1] P. Mahadevan, D. Krioukov, K. Fall, and A. Vahdat, "Systematic topol- ogy analysis and generation using degree correlations," Acm Sigcomm Computer Communication Review, vol. 36, pp. 135–146, 2006. [2] C. Orsini, M. M. Dankulov, P. Colomer-de Simón, A. Jamakovic, P. Mahadevan, A. Vahdat, K. E. Bassler, Z. Toroczkai, M. Boguñá, G. Caldarelli et al., "Quantifying randomness in real networks," Nature communications, 2015. [3] M. Gjoka, B. Tillman, and A. Markopoulou, "Construction of simple 2015 IEEE graphs with a target joint degree matrix and beyond." Conference on Computer Communications (INFOCOM), 2015. [4] R. Milo, S. Shen-Orr, S. Itzkovitz, N. Kashtan, D. Chklovskii, and U. Alon, "Network motifs: simple building blocks of complex networks," Science, 2002. [5] Ö. N. Yaveroglu, N. Malod-Dognin, D. Davis, Z. Levnajic, V. Janjic, R. Karapandza, A. Stojmirovic, and N. Pržulj, "Revealing the hidden language of complex networks," Scientific reports, 2014. [6] B. Donnet and T. Friedman, "Internet topology discovery: a survey," IEEE Communications Surveys Tutorials, vol. 9, no. 4, pp. 56–69, 2007. [7] M. H. Gunes and K. Sarac, "Resolving Anonymous Routers in Internet Topology Measurement Studies," in IEEE INFOCOM 2008 - The 27th Conference on Computer Communications, April 2008. [8] A. Mislove, M. Marcon, K. P. Gummadi, P. Druschel, and B. Bhattacharjee, "Measurement and Analysis of Online Social Networks," in Proceedings of the 7th ACM SIGCOMM Conference on Internet Measurement, ser. IMC '07. New York, NY, USA: ACM, 2007, pp. 29–42. [Online]. Available: http://doi.acm.org/10.1145/ 1298306.1298311 [9] F. Benevenuto, T. Rodrigues, M. Cha, and V. Almeida, "Characterizing User Behavior in Online Social Networks," in IMC, ser. IMC '09. New York, NY, USA: ACM, 2009, pp. 49–62. [Online]. Available: http://doi.acm.org/10.1145/1644893.1644900 [10] R. Aldecoa, C. Orsini, and D. Krioukov, "Hyperbolic graph generator," Computer Physics Communications, vol. 196, pp. 492 – 496, 2015. [Online]. Available: http://www.sciencedirect.com/science/article/ pii/S0010465515002088 [11] M. E. J. Newman, Networks: an introduction. Oxford university press, 2010. [12] S. Wasserman and K. Faust, Social Network Analysis: Methods and Applications. Cambridge: Cambridge University Press, 1994. [13] S. J. Axler, Linear algebra done right. Springer, 1997. [14] L. Mirsky, "Symmetric gauge functions and unitarily invariant norms," The quarterly journal of mathematics, vol. 11, pp. 50–59, 1960. [15] G. Robins, P. Pattison, Y. Kalish, and D. Lusher, "An introduction to exponential random graph (p*) models for social networks," Social Networks, vol. 29, no. 2, pp. 173 – 191, 2007, special Section: Advances in Exponential Random Graph (p*) Models. [Online]. Available: http://www.sciencedirect.com/science/article/pii/S0378873306000372 [16] S. Trajanovski, and P. Van Mieghem, "Generating graphs that approach a prescribed modularity," Computer Communications, vol. 36, no. 4, 2013. J. Martín-Hernández, F. A. Kuipers, [17] B. Karrer and M. E. J. Newman, "Stochastic blockmodels and commu- nity structure in networks," Physical Review E, vol. 83, no. 1, 2011. [18] P. D. Hoff, A. E. Raftery, and M. S. Handcock, "Latent Space the American Approaches to Social Network Analysis," Journal of Statistical Association, vol. 97, no. 460, pp. 1090–1098, 2002. [19] K. Nowicki and T. A. B. Snijders, "Estimation and Prediction for Stochastic Blockstructures," Journal of the American Statistical Asso- ciation, vol. 96, no. 455, pp. 1077–1087, 2001. [20] M. E. J. Newman, "Spectral methods for community detection and graph partitioning," Phys. Rev. E, vol. 88, p. 042822, Oct 2013. [21] W. D. Richards and A. J. Seary, "Multinet. Version 4.38 for Windows," 2003. [22] M. E. J. Newman, "Modularity and community structure in networks," PNAS, vol. 103, pp. 8577–8582, June 2006. [23] J. S. Coleman, Introduction to mathematical sociology. London Free Press Glencoe, 1964. [24] L. Freeman, The development of social network analysis: a Study in the Sociology of Science. BookSurgePublishing, 2004. [25] S. P. Borgatti and M. G. Everett, "Models of core/periphery structures," Social Networks, vol. 21, pp. 375–395, 1999. [26] C. D. Meyer, Matrix analysis and applied linear algebra. Siam, 2000. [27] M. Girvan and M. E. J. Newman, "Community structure in social and biological networks," Proceedings of the national academy of sciences, vol. 99, no. 12, pp. 7821–7826, 2002. [28] A. Lancichinetti, S. Fortunato, and F. Radicchi, "Benchmark graphs for testing community detection algorithms," Physical review E, vol. 78, no. 4, p. 046110, 2008. [29] K. M. Harris, C. T. Halpern, E. Whitsel, J. Hussey, J. Tabor, P. Entzel, and J. R. Udry, "The national longitudinal study of ado- lescent to adult health: Research design," See http://www. cpc. unc. edu/projects/addhealth/design (accessed 9 April 2015), 2009. [30] J. J. Mcauley and J. a. Leskovec, "Learning to discover social circles in ego networks," in Advances in neural information processing systems, 2012, pp. 539–547. [31] T. A. B. Snijders and K. Nowicki, "Estimation and prediction for stochastic block models for graphs with latent block structure," Journal of Classification, vol. 14, pp. 75–100, 1997. [32] V. D. Blondel, J.-L. Guillaume, R. Lambiotte, and E. Lefebvre, "Fast unfolding of communities in large networks," Journal of statistical mechanics: theory and experiment, vol. 2008, no. 10, p. P10008, 2008. [33] S. Fortunato, "Community detection in graphs," Physics Reports, [Online]. Available: vol. 486, no. 3, pp. 75 – 174, 2010. http://www.sciencedirect.com/science/article/pii/S0370157309002841 [34] S. Ji, W. Li, P. Mittal, X. Hu, and R. A. Beyah, "SecGraph: A Uniform and Open-source Evaluation System for Graph Data Anonymization and De-anonymization." in Usenix Security, 2015, pp. 303–318. [35] M. Srivatsa and M. Hicks, "Deanonymizing mobility traces: Using social network as a side-channel," in Proceedings of the 2012 ACM conference on Computer and communications security. ACM, 2012, pp. 628–637. Code," "Spectral Baldesi, [36] L. Source Graph Forge - https://github.com/lucabaldesi/spectral_graph_forge, December 2017. Fig. 10. Normalization function comparison in the interval (0.5, 1.5). APPENDIX A: α-TUNABLE CONVERGENCE OF M TO M The distance between M and M due to the low pass filter at the second step of the pipeline indicates how much information we dropped from the transformed matrix M. We measure this distance using the Euclidean norm, , a well-known metric on spaces of real-valued matrices. This is distance is directly related to the spectral radius: (cid:13)(cid:13)(cid:13)2 (cid:13)(cid:13)(cid:13)M − M (cid:13)(cid:13)(cid:13)(cid:13)(cid:13)(cid:13)2  n(cid:88) = ρ (cid:13)(cid:13)(cid:13)M − M (cid:13)(cid:13)(cid:13)2 = (cid:13)(cid:13)(cid:13)(cid:13)(cid:13)(cid:13) n(cid:88)  , λivivT i i=(cid:100)αn(cid:101)+1 λivivT i i=(cid:100)αn(cid:101)+1 where ρ(·) is the spectral radius function. Knowing that the eigenvalues of M are ordered with respect their moduli, λ1 ≥ ··· ≥ λn, we obtain(cid:13)(cid:13)(cid:13)M − M (cid:13)(cid:13)(cid:13)2 = λ(cid:100)αn(cid:101)+1, which is the largest eigenvalue not included in our approxima- tion M. Hence, our method allows us to target the reproduction of M with arbitrary precision in the Euclidean norm. Indeed, we can guarantee exact preservation of M in the limit as α → 1, since ∀ ∈ R+ ∃α ∈ [0, 1] ≤ . Typically, we will deliberately select α < 1 to remove information in M that is idiosyncratic to A, but the Spectral Graph Forge allows users to bring M as close to M as needed for the application in question. (cid:13)(cid:13)(cid:13)M − M (cid:13)(cid:13)(cid:13)2 : APPENDIX B: IMPACT OF NORMALIZATION ON M -PRESERVATION AND ENTROPY Fig. 10 presents the different normalizing functions in the interval (−0.5, 1.5). The normalization applied by scale() introduces a distortion highly dependent on the difference between the minimum and maximum values (with k = 6 providing the best performance) and the logistic() introduces noise by remaining strictly within (0, 1) for all Ai,j. Prelimi- nary experiments showed that with k = 6 the logistic function provided the best performance in the cases studied here, and we use this value in the analyses that follow. In addition to spectral filtering, details of the original input graph are removed by normalization. It is hence useful to Fig. 11. Baseline and normalized A, A distances for Erdos-Rényi graphs (upper plot) and Barabási-Albert graphs (lower plot), by α. Ideally, normed matrix distances should be close to (cid:107)A − A(cid:107). examine how different choices of normalization function alter both the degree of "smoothing" in the graph generation process (measured by the mean Euclidean norm between the initial and generated graph) and the entropy of the resulting graph distribution. To this end we measure the distortion low-rank approximation introduces in an adjacency matrix through a simulation experiment with input graphs drawn from a set of realizations from Erdos-Rényi and Barabási-Albert graph generation processes; our input set was composed of 10 random Erdos-Rényi graphs and 10 random Barabási-Albert graphs, each having n = 100 nodes and the same approximate mean degree of ∼ 4.5. Fig. 11 shows Euclidean norms for the respective samples, as a function of α. These norms represent matrix distances and, hence, they span in the interval (0,∞). The patterns are quite similar for Erdos-Rényi and Barabási-Albert graph types, with the exception of the limiting distance in the case when α → 0 (where at most one eigenvalue is employed). As noted in section VI, (cid:107)A− A(cid:107) → 0 as α → 1 (since we have chosen M = A); however, some of this information may be lost by normalization. In particular Fig. 11 shows a comparison among the normalization functions and the distance they in- troduce from the spectral-approximated matrix A. Ideally, we do not want the normalization function to introduce systematic variation in this space, as the approximation introduced by SGF should rely only on the spectral approximation. Hence, the distance (cid:107) A − norm( A) (cid:107) should be as close as possible to (cid:107) A − A (cid:107). As can be noted in Fig. 10 the scale function introduces considerable noise, a phenomenon also seen in Fig. 11. Both truncation and logistic approaches obtain a distance very close to the spectral approximation, but only truncation preserves convergence to 0 when α → 1. Fig. 12 shows the entropy computation for the same graphs 0 0.2 0.4 0.6 0.8 1 1.2-0.5 0 0.5 1 1.5xscale(x)trunc(x)logistic(x,2)logistic(x,6)logistic(x,10) 0 5 10 15 20 25 30 35Euclidean distanceA − Ã2A-truncate(Ã)2A-logistic(Ã)2A-scale(Ã)2 0 5 10 15 20 0 0.2 0.4 0.6 0.8 1Euclidean distanceα during the same runs. Entropy here represents the expected number of bits required to describe A(cid:48) given the generating distribution. We normalize this value for a fair comparison among graphs with different densities. As would be expected, entropy is lowest when all eigenvectors of the original graph are included, and increases as constraints are reduced. How- ever, the choice of normalization function affects the extent to which information from A contributes to A(cid:48). Overall, scaling and truncation rules show the smoothest entropy enhancement, with the logistic rule showing the least effect; this is because the prior functions yield a larger change in tie probability given a fixed change in cell value over the range encountered in these tests. It is worth noticing the highly variable behaviour of the scale() function which, although it follows a clear trend, it is strongly influenced by the maximum and minimum values of A, leading to high variance and non-monotonicity when α → 0. Fig. 12. Entropy of generated graphs using three different normalization functions for Erdos-Rényi input graphs (upper plot) and Barabási-Albert graphs (lower plot) computed for different values of α. The above suggest that the cleanest entropy and distance relationships are found for the truncation rule. 0 0.3 0.6 0.9 1.2 1.5 1.8 2.1Normalized EntropyH(truncate(Ã)H(logistic(Ã,6))H(scale(Ã)) 0 0.3 0.6 0.9 1.2 1.5 1.8 0 0.2 0.4 0.6 0.8 1Normalized Entropyα
1802.05536
2
1802
2018-08-20T16:37:18
Graph Operator Modeling over Large Graph Datasets
[ "cs.SI", "physics.soc-ph" ]
As graph representations of data emerge in multiple domains, data analysts need to be able to intelligently select among a magnitude of different data graphs based on the effects different graph operators have on them. Exhaustive execution of an operator over the bulk of available data sources is impractical due to the massive resources it requires. Additionally, the same process would have to be re-implemented whenever a different operator is considered. To address this challenge, this work proposes an efficient graph operator modeling methodology. Our novel approach focuses on the inputs themselves, utilizing graph similarity to infer knowledge about input graphs. The modeled operator is only executed for a small subset of the available graphs and its behavior is approximated for the rest of the graphs using machine learning techniques. Our method is operator-agnostic, as the same similarity information can be reused for modeling multiple graph operators. We also propose a family of similarity measures based on the degree distribution that prove capable of producing high quality estimations, comparable or even surpassing other much more costly, state-of-the-art similarity measures. Our evaluation over both real-world and synthetic graphs indicates that our method achieves extremely accurate modeling of many commonly encountered operators, managing massive speedups over a brute-force alternative.
cs.SI
cs
Graph Operator Modeling over Large Graph Datasets (Extended Version) Tasos Bakogiannis1, Ioannis Giannakopoulos1, Dimitrios Tsoumakos2 and Nectarios Koziris1 1 Computing Systems Laboratory School of ECE, NTUA, Athens, Greece {abk, ggian, nkoziris}@cslab.ece.ntua.gr 2 Department of Informatics Ionian University, Corfu, Greece [email protected] 8 1 0 2 g u A 0 2 ] I S . s c [ 2 v 6 3 5 5 0 . 2 0 8 1 : v i X r a Abstract As graph representations of data emerge in multiple do- mains, data analysts need to be able to intelligently se- lect among a magnitude of di(cid:130)erent data graphs based on the e(cid:130)ects di(cid:130)erent graph operators have on them. Ex- haustive execution of an operator over the bulk of avail- able data sources is impractical due to the massive re- sources it requires. Additionally, the same process would have to be re-implemented whenever a di(cid:130)erent operator is considered. To address this challenge, this work pro- poses an e(cid:129)cient graph operator modeling methodology. Our novel approach focuses on the inputs themselves, utilizing graph similarity to infer knowledge about in- put graphs. (cid:140)e modeled operator is only executed for a small subset of the available graphs and its behavior is approximated for the rest of the graphs using machine learning techniques. Our method is operator-agnostic, as the same similarity information can be reused for mod- eling multiple graph operators. We also propose a fam- ily of similarity measures based on the degree distribu- tion that prove capable of producing high quality estima- tions, comparable or even surpassing other much more costly, state-of-the-art similarity measures. Our evalua- tion over both real-world and synthetic graphs indicates that our method achieves extremely accurate modeling of many commonly encountered operators, managing mas- sive speedups over a brute-force alternative. 1 Introduction Graph Analytics has been gaining an increasing amount of a(cid:138)ention in recent years. Driven by the surge in so- cial and business graph data, graph analytics is used to e(cid:130)ectively tackle complex tasks in many areas such as bioinformatics, social community analysis, tra(cid:129)c opti- mization, fraud detection, etc. A diverse collection of graph operators exists [14], with functionality typically including the computation of centrality measures, clus- tering metrics or network statistics [10]. Yet, as Big Data technologies mature and evolve (with regular advances in Big Graph Systems [39]), emphasis is placed on areas not solely related to data (i.e., graph) size. A di(cid:130)erent type of challenge steadily shi(cid:137)s a(cid:138)en- tion to the actual content: In content-based analytics [17], data from social media platforms is processed for sense-making. Similarly, in content-sensitive applications such as recommendation systems, web advertising, credit analysis, etc., the quality of the insights derived is mainly a(cid:138)ributed to the input content. (cid:140)e plethora of available sources for content-sensitive analytics tasks now creates an issue: Data scientists need to decide which of the available datasets should be fed to a given work(cid:131)ow inde- pendently, in order to maximize its impact. Yet, as mod- ern analytics tasks have evolved into increasingly long and complex series of diverse operators, evaluating the utility of immense numbers of inputs is prohibitively ex- pensive. (cid:140)is is notably true for graph operators, whose computational cost has led to extensive research on ap- proximation algorithms (e.g., [34, 15]). As a motivating example, let us consider a dataset con- sisting of a very large number of citation graphs. We wish to identify the graphs that have the most well-connected citations and contain highly cited papers. (cid:140)e clustering coe(cid:129)cient [10], a good measure of neighborhood connec- tivity, would have to be computed for all the graphs in the dataset in order to allow the identi(cid:128)cation of the top- k such graphs. To quantify the importance of each paper, we consider a centrality measure such as betweenness centrality [10]. Consequently, we would have to compute the maximum betweenness centrality score for each cita- tion graph and combine the results with those obtained from the analysis based on the clustering coe(cid:129)cient. Yet, this is a daunting task due to the operators' complexity and the number of executions required. It is not straight- forward how the di(cid:130)erent input graphs a(cid:130)ect the out- put of the clustering coe(cid:129)cient or betweenness central- ity metrics. For traditional algorithms, performance is driven by algorithmic complexity usually tied to the in- put size. In Big Data Analytics, such analyses cannot be intuitively deduced [22]. (cid:140)e challenge this work tackles is thus the following: Given a graph analytics operator and a large number of input graphs, can we reliably predict operator output for every input graph at low cost? How can we rank or tan- gibly characterize input datasets relative to their e(cid:130)ect on job execution? In this work, we introduce a novel, operator-agnostic dataset pro(cid:128)ling mechanism: Rather that executing the operator over each input separately, our work assesses the relationship between the dataset's graphs. Based on graph similarity, we infer knowledge about them. In our example, instead of exhaustively com- puting the clustering coe(cid:129)cient, we calculate a similar- ity matrix for our dataset, compute the clustering coe(cid:129)- cient for a small subset of graphs and utilize the similar- ity matrix to estimate its remaining values. We may then compute the maximum betweenness centrality for also a small subset of citation graphs and reuse the already cal- culated similarity matrix to estimate betweenness cen- trality scores for the rest of the graphs. Our method is based on the intuition that, for a given graph operator, similar graphs produce similar outputs. (cid:140)is intuition is solidly supported by the existence of strong correlations between di(cid:130)erent graph operators ([26, 9, 24]). Hence, by assuming a similarity mea- sure that correlates to a set of operators, we can use machine learning techniques to approximate their out- comes. Given a graph dataset and an operator to model, our method utilizes a similarity measure to compute the similarity matrix of the dataset, i.e., all-pairs similarity scores between the graphs of the dataset. (cid:140)e given op- erator is then run for a small subset of the dataset; using the similarity matrix and the available operator outputs, we are able to approximate the operator for the remain- ing graphs. To the best of our knowledge, this is the (cid:128)rst e(cid:130)ort to predict graph operator output over very large numbers of available inputs. In summary, we make the following contributions in this work: • We propose a novel, similarity-based method to esti- mate graph operator output for very large numbers of input graphs. (cid:140)e method shi(cid:137)s the complexity of nu- merous graph computations to less expensive pairs of similarities. (cid:140)is choice o(cid:130)ers two major advantages: First, our scheme is operator-agnostic: (cid:140)e resulting similarity matrix can be reused by di(cid:130)erent operators, amortizing its computation cost. As a result, the cost of our method is ultimately dominated by the compu- tation of that operator for a small subset of the dataset. Second, the method is agnostic to the similarity mea- sure that is used. (cid:140)is property gives us the ability to utilize or arbitrarily combine di(cid:130)erent similarity mea- sures. • We introduce a family of similarity measures based on the degree distribution with a gradual tradeo(cid:130) be- tween detail and computation complexity. Despite their simplicity, they prove capable of producing high quality estimations, comparable or even surpassing other more costly, state-of-the-art similarity measures ([36, 38]). • We improve on the complexity of the similarity ma- trix computation by providing an alternative to calcu- lating all-pairs similarity scores. We propose, instead, to initially cluster a given dataset to groups of simi- lar graphs using the inverse of the similarity measure as a distance metric. (cid:140)en, calculate all-pairs similar- ities for each cluster, assuming inter-cluster similarity scores to equal zero. In our experimental evaluation we observe that this approach can lead to up to 15× speedup in similarity matrix calculations while having li(cid:138)le to no e(cid:130)ect on modeling accuracy. • We o(cid:130)er an open-source implementation1 of our method and perform an extensive experimental eval- uation using both synthetic and real datasets. Our re- sults indicate that the similarity-based approach is ac- curately modeling a variety of popular graph opera- tors, with errors even < 1%, sampling a mere 5% of the graphs for execution. Amortizing the similarity cost over six operators, modeling is sped up to 18× compared to exhaustive modeling. Our proposed sim- ilarity measures produce similar or more accurate re- sults compared to state-of-the-art similarity measures but run more than 5 orders of magnitude faster. Fi- nally, our analysis provides insights on the connection between di(cid:130)erent operators and the respective simi- larity functions, demonstrating the utility of similarity matrix composition. 2 Methodology In this section, we formulate the problem and describe the methodology along with di(cid:130)erent aspects of the pro- posed solution. We start o(cid:130) with some basic notation fol- lowed throughout the paper and a formal description of our method and its complexity. Let a graph G be an ordered pair G = (V, E) with V being the set of vertices and E the set of edges of G, respectively. (cid:140)e degree of a vertex u ∈ V , denoted by dG(u), is the number of edges of G incident to u. (cid:140)e degree distribution of a graph G, denoted by PG(k), ex- presses the probability that a randomly selected vertex of G has degree k. A dataset D is a set of N simple, undi- rected graphs D = {G1, G2, ..., GN}. We de(cid:128)ne a graph operator to be a function g : D → R, mapping an element of D to a real number. In order to quantify the similarity between two graphs Ga, Gb ∈ D we use a graph simi- larity function s : D × D → R with range within [0, 1]. For two graphs Ga, Gb ∈ D, a similarity of 1 implies that they are identical while a similarity of 0 the opposite. 1h(cid:138)ps://github.com/giagiannis/data-pro(cid:128)ler Consequently, the problem we are addressing can be formally stated as follows: Given a dataset of graphs D and a graph operator g, without knowledge of the range of g given D, we wish to infer a function g : D → R that approximates g. Additionally, we wish our approxima- tion to be both accurate (i.e., g − g < , for some small ) and e(cid:129)cient (i.e., O(g) < O(g)). We observe that, although this formulation resembles a function approx- imation problem, the two additional requirements men- tioned di(cid:130)erentiate it from a typical problem of this class. In such problems, we have knowledge of the entire out- put space of g for a given dataset. Moreover, no complex- ity restrictions are posed. In this formulation, our goal is to provide an accurate approximation of g, while avoid- ing its exhaustive execution over the entire D. Figure 1: Methodology Pipeline To achieve this goal, we utilize the similarity matrix R, an N × N matrix with R[i, j] = s(Gi, Gj), where s is a given similarity measure. As a result, R contains all-pairs similarity scores between the graphs of D. R is symmet- ric, its elements are in [0, 1] and the entries of its main diagonal equal 1. Our method takes as input a dataset D and an operator g to model. It forms the pipeline depicted in Figure 1: It begins with the computation of the similar- ity matrix R based on s; it calculates the actual values of g for a ratio p ∈ (0, 1) of randomly selected graphs of D, referred to as Dp. Finally, it estimates g for the remain- ing graphs of D by running a weighted version of the k-Nearest-Neighbors (kNN) algorithm [23]. (cid:140)e inferred function g is then given by the following equation: (cid:80) (cid:80) g(Gx) = i∈Γk(x) wxig(Gi) i∈Γk(x) wxi (1) Where wxi = R[x, i] is the similarity score for graphs Gx, Gi, i.e., wxi = s(Gx, Gi), Γk(x) is the set of the k most similar graphs to Gx for which we have already cal- culated g and g(Gi) the value of the operator for Gi. Our approach is formally described in Algorithm 1. (cid:140)e complexity of Algorithm 1 can be broken down to its three main components. First, there is the calculation of the similarity matrix R in lines 3 − 4, which, for a given similarity measure s with complexity S, runs in O(N 2S). (cid:140)e second component (lines 5 − 7), which computes the operator g for pN graphs, has complexity O(pN M ), assuming that g has complexity of M. (cid:140)e for x ← [G1, G2, ..., GN ], x /∈ keys(T ) do R ← [ ], T ← { }, A ← { } for (i, j) ← [1, N ] × [1, N ] do R[i, j] ← s(Gi, Gj) for i ← 1, p · N do r ← randint(1, N ) T [Gr] ← g(Gr) t ← f indN eighbors(R, T, k, x) A[x] ← calcApproximation(R, t) Algorithm 1 Graph Operators Modeling 1: procedure Approximate([G1, ..., GN ], g, s, p, k) 2: 3: 4: 5: 6: 7: 8: 9: 10: 11: approximation of the operator for the remaining graphs (lines 8− 10) runs in O((N (1− p))((pN )log(pN ) + k)) since, for each of the remaining dataset graphs (which are N (1 − p)), we (cid:128)rst sort the similarities of our training set (T ) in order to (cid:128)nd the k nearest neighbors to each unknown point (f indN eighbors), an operation of O((pN )log(pN )) complexity. We then perform k iterations to calculate the weighted sum of Equ. 1 (calcApproximation). (cid:140)us, the complexity of our method is: return A O(N 2S + pN M + (N (1− p))((pN )log(pN ) + k)) (2) From Equ. 2, we deduce that the complexity of our method is dominated by its (cid:128)rst two components. Conse- quently, the lower the computational cost of s, the more practical our approach will be. Additionally, we expect our training set to be much smaller than our original dataset (i.e., p (cid:28) 1), otherwise the second component will approach N M, which is no di(cid:130)erent that calculat- ing the operator for the entire dataset. It is important to note here that the O(N 2S) compo- nent corresponds to a calculation performed only once, whether modeling a single or multiple operators. In- deed, as we show in this work, there exist both intu- itive and simple to compute operators that can be uti- lized for a number of di(cid:130)erent graph tasks. Moreover, our methodology allows for composition of similarity ma- trices, permi(cid:138)ing combinations of di(cid:130)erent measures. Given that the similarity matrix calculation happens once per dataset, its cost gets amortized over multiple graph operators, making the O(pN M ) factor the dominant one for our pipeline. 2.1 Similarity Measures (cid:140)e similarity matrix is an essential tool in our e(cid:130)orts to model graph operators under the hypothesis that simi- lar graphs produce similar operator outputs. (cid:140)is would also suggest a connection between the similarity mea- sure and the graph operators we consider. Relative to SIMILARITY ESTIMATION(s)...kNN MODELg(Gi), Gi∈Dp⊆Dĝsimilarity matrixD graph analytics operators, we propose a family of simi- larity measures based on graph degree distribution. Rein- forced by the proven correlations between many diverse graph operators ([26, 9, 24]), we intend the proposed sim- ilarity measures to express graph similarity in a way that enables modeling of multiple operators at low cost. (cid:46) Degree Distribution: In order to quantify the simi- larity between two graphs we rely on comparing their degree distributions. We compute the degree distribu- tions from the graph edge lists and compare them using the Bha(cid:138)acharyya coe(cid:129)cient BC [6]. BC is considered a highly advantageous method for comparing distributions [1]. ered. BC is thus calculated by: BC(q, r) =(cid:80)m BC divides the output space of a function into m par- titions and uses the cardinality of each partition to cre- ate an m-dimensional vector representing that space. As a measure of divergence between two distributions, the square of the angle between the two vectors is consid- qiri, where q, r are the two samples, m the number of parti- tions created by the algorithm and qi, ri the cardinality of the i-th partition of each sample. In our case, the two samples represent the graphs we intend to compare and the points in our space are the degrees of the nodes of each graph. By dividing that space into partitions and considering the cardinalities of each partition, we e(cid:130)ec- tively compare the degree distributions of those graphs. In our implementation, we use a k-d tree [5], a data structure used for space partitioning to compute BC. We build a k-d tree once, based on a prede(cid:128)ned percent- age of vertex degrees from all the graphs in D. We then use the created space partitioning to compute de- gree distributions for each graph. By using the median of medians algorithm [12], this process has complexity O(νlogν +NV logν), where ν is the number of vertices used to build the tree. √ i=1 Generalizing this idea to more than one levels gives us a measure of the indirect connectivity of a vertex. By com- bining the degrees of a vertex for multiple levels we get information about its connectivity up to level hops away. As an illustrative example, in Figure 2 vertex u0 has de- gree 4, when considering its direct neighbors. When its neighborhood is expanded to level 1, u0's degree is 1 and for level 2 it becomes 3. Based on this idea, we quantify the similarity between graphs by calculating the degrees up to a certain level for each vertex of the graphs and use BC to compare the re- sulting degree distributions. A good property of this class of measures is that they provide us with a nice trade- o(cid:130) between accuracy and computational cost. Increas- ing the number of degree distribution levels involves ad- ditional computations but also incorporates more graph topological insights to it. In order to calculate the degrees for a given level, for each vertex we perform a depth- limited Depth First Search up to level hops away in order to mark the internal edges of the supernode. We then count the edges of the border vertices (vertices level hops away from the source) that do not connect to any internal vertices. (cid:140)e complexity of this algorithm is O(V (d)l) where d is the average branching factor (average degree) and l the level-depth limit. (cid:46) Degree Distribution + Vertex Count A second ex- tension to our degree distribution-based similarity mea- sure is based on the ability of our method to com- bine similarity matrices. Graph size, in terms of vertex count, is another graph a(cid:138)ribute to measure similarity on. We formulate similarity in terms of vertex count as: . Intuitively, s approaches s(Gi, Gj) = 1 when VGi − VGj approaches 0, i.e., when Gi, Gj have similar vertex counts. To incorporate vertex count into the graph comparison, we can combine the similarity matrices computed with degree distributions and vertex counts using an arbitrary formula (e.g., linear composi- tion). min(VGi,VGj ) max(VGi,VGj ) Figure 2: Example of Degree Distribution + Levels (cid:46) Degree Distribution + Levels: As an extension of the degree distribution-based similarity measure, we con- sider a class of measures with increasing levels of infor- mation. (cid:140)e intuition behind it is that the degree of a vertex is a measure of its connectivity based on its imme- diate neighbors. For instance, we can de(cid:128)ne the degree of a vertex at level 1 as the degree of a supernode contain- ing the vertex and all its immediate neighbors. Internal edges of the supernode do not contribute to his degree. 2.2 Similarity Matrix Speedup Computation Based on Equ. 2, the complexity of our method is primar- ily dominated by the (cid:128)rst two components and specif- ically by the similarity matrix calculation. Although it refers to a one time computation and its cost is being amortized with modeling of multiple graph operators, having to compute all-pairs similarity scores for a large collection of graphs can be prohibitively expensive (in the order of O(N 2) for N graphs). Here, we introduce a preprocessing step which we argue that improves the existing computational cost, reducing the number of sim- ilarity calculations performed. u7u5u6u3u1u0u2u4u8Level 1 = 1Level 0 = 4Level 2 = 3 As, in order to approximate a graph operator, we em- ploy kNN, we observe that, for each graph, we only re- quire the similarity scores to its k most similar graphs for which we have the value of g, i.e., the weights in Equ. 1. (cid:140)e remaining similarity scores involving this graph are not used. (cid:140)erefore we propose, as a (cid:128)rst step, to run a clustering algorithm which will produce clus- ters of graphs with high similarity. (cid:140)en for each cluster compute all-pairs similarity scores between its members. Inter-cluster similarities are assumed to be zero and are not computed. By creating clusters of size much larger than k, we expect minimal loss in accuracy while avoid- ing a considerable number of similarity computations. As a clustering algorithm we use a simpli(cid:128)ed version of k-medoids in combination with k-means++, for the initial seed selection ([28, 2]). We aim at creating clus- ters much larger than the required k elements of kNN and therefore do not consider necessary to recalculate the cluster medoids at each iteration of the k-medoids algorithm. In addition, we rely on k-means++ to spread out the cluster medoids, something that has been proven to give be(cid:138)er clustering results [2]. Consequently, our approach runs k-means++ to (cid:128)nd k cluster centers and groups the graphs based on their distances to those cen- ters. (cid:140)en, for each cluster computes all-pairs similarity scores between its members. As a distance measure we consider the inverse of the similarity measure we employ, that is d(Gi, Gj) = 1 − s(Gi, Gj). Assuming the pro- , c being the number of duced cluster sizes are close to N c clusters created, the similarity computations performed c +N c) . (cid:140)us, by se(cid:138)ing c = are in the order of O( N 2 √ N we can achieve O(N N ) similarity computations for a dataset of N graphs. √ 2.3 Discussion In this section, we consider a series of issues that relate to the con(cid:128)guration and performance of our method as well as to the relation between modeled operators, similarity measure and input datasets. (cid:46) Graph Operators: In this work, we focus on graph an- alytics operators, namely centralities, clustering metrics, network statistics, etc. Research on this area has resulted in a large collection of operators, also referred to as topol- ogy metrics, with new ones being constantly added (e.g., [14, 10, 9, 24]). Topology metrics can be loosely classi- (cid:128)ed in three broad categories ([26, 9, 24]): (cid:140)ose related to distance, connectivity and spectrum. In the (cid:128)rst class, we (cid:128)nd metrics that involve distances between vertices such as diameter, average distance and betweenness cen- trality. (cid:140)e second class relates to vertex degrees contain- ing metrics such as average degree, degree distribution, clustering coe(cid:129)cient, etc. Finally, the third class comes from the spectral analysis of a graph and contains the computation of eigenvalues, the corresponding eigenvec- tors or other spectral-related metrics. (cid:46) Similarity Matrix and Graph Operators: An aspect we take under consideration is the similarity measure we employ in relation to the graph operator we intend to model. Research has identi(cid:128)ed strong correlations be- tween certain classes of graph operators, for example topology metrics ([26, 9, 24]). It is thus safe to assume that if, for example, we base our similarity calculations on a degree-related measure, we should be more successful in modeling degree-related graph operators than distance- related. In practice, the analyst should have some level of intuition on the type of graph operators to be modeled. In our experimental evaluation, we model operators from all three aforementioned operator classes in order to eval- uate the e(cid:129)ciency of the proposed similarity measures. (cid:46) Combining Similarity Measures: We can think of use cases where we want to quantify the similarity of graphs based on parameters unrelated to each other which cannot be expressed by a single similarity mea- sure. For example, we might want to compare two graphs based on their degree distributions but also take under account their order (vertex count). Essentially, we would like to be able to combine multiple independent similar- ity measures. (cid:140)is composition can be naturally imple- mented in our system. We can compute independent sim- ilarity matrices for each of our similarity measures and "fuse" those matrices into one based on a given formula. (cid:140)is technique is presented in our experimental evalua- tion and proves e(cid:130)ective in a number of operators. (cid:46) Regression Analysis Although there exist several ap- proaches to statistical learning [23], we have opted for the kNN method. We choose kNN for its simplicity and because we do not have to calculate distances between points of our dataset (we already have that information from the similarity matrix). (cid:140)e kNN algorithm is also suitable for our use case since it is sensitive to localized data and insensitive to outliers. A desired property, since we expect similar graphs to have similar operator scores and should therefore be of in(cid:131)uence in our estimations. Conversely, we expect operator scores for graphs of low similarity to have li(cid:138)le or no in(cid:131)uence on score estima- tions. 3 Experimental Evaluation 3.1 Experimental Setup (cid:46) Datasets: For our experimental evaluation, we con- sider both real and synthetic datasets. (cid:140)e real datasets comprise a set of ego graphs from Twi(cid:138)er (TW) which consists of 973 user "circles" as well as a dataset contain- ing 733 snapshots of the graph that is formed by consid- ering the Autonomous Systems (AS) that comprise the Internet as nodes and adding links between those sys- tems that communicate to each other. Both datasets are taken from the Stanford Large Network Dataset Collec- tion [30]. We also experiment with a dataset of synthetic graphs (referred to as the BA dataset) generated using the SNAP library [31]. We use the GenPrefAttach generator to create random scale-free graphs with power-law degree distributions using the Barabasi-Albert model [4]. (cid:140)e degree distribution of the synthetic graphs, according to this model, can be given by: P (k) ∼ k−γ, where γ = 3. We keep the vertex count of the graphs constant to 4K. We introduce randomness to this dataset by having the initial outdegree of each vertex be a uniformly random number in the range [1, 32]. (cid:140)e Barabasi-Albert model constructs a graph by adding one vertex at a time. (cid:140)e initial outdegree of a vertex is the maximum number of vertices it connects to, the moment it is added to the graph. (cid:140)e graphs of the dataset are simple and undi- rected. Further details about the datasets can be found in Table 1. (cid:46) Similarity Measures: We evaluate all the similarity measures proposed in Section 2.1, namely degree distri- bution + levels, for levels 0, 1, 2 and degree distribution + vertex count. When combining vertex count with degree, we use the following simple formula: R = w1Rd+w2Rn, with Rd, Rn the degree distribution and vertex count similarity matrices respectively. In our evaluation we set: w1 = w2 = 0.5. To investigate their strengths and limitations, we com- pare them against two measures functioning as our base- lines. (cid:140)e (cid:128)rst is a sophisticated similarity measure not based on degree but rather on distance distributions (from which the degree distribution can be deduced). D- measure [36] is based on the concept of network node dispersion (NND) which is a measure of the heterogene- ity of a graph in terms of connectivity distances. From a computational perspective, D-measure is based on the all-pairs shortest paths algorithm, which can be imple- mented in O(E + V log(V )) using Fibonacci heaps. It is a state-of-the-art graph similarity measure with very good experimental results for both real and synthetic graphs. It is considered e(cid:129)cient and since it incorpo- rates additional information to the degree distribution, it is suitable to reason about how su(cid:129)cient the measures we propose are. Our second baseline comes from the extensively re- searched area of graph kernels. Kernel methods for com- paring graphs were (cid:128)rst introduced in [19]. Many ker- nels have been since proposed to address the problem of similarity in structured data [20]. In our evaluation, we incorporate the Random Walk Kernel [19] which in- tuitively performs random walks on a pair of graphs and counts the number of matching walks as a measure of Table 1: Datasets overview TW AS BA 4,000 973 733 1,000 4,000 66,865 Name Size (N) E Range V Range E V 1,841 min: 132 max: 4,183 8,540 min: 9 6 min: 12,387 248 max: 248 103 min: 13,895 max: 6,474 max: min: 3,999 max: 127,472 their similarity. For the purposes of our evaluation, we opted for the geometric Random Walk Kernel (rw-kernel) as a widely used representative of this class of similar- ity measures. (cid:140)e complexity of random walk kernels is in the order of O(V 6), however faster implementations with speedups up to O(V 2) exist [38]. In order to avoid the halting phenomenon due to the kernel's decay factor (λk) we set λ = 0.1 and the number of steps k ≤ 4, val- ues that are considered to be reasonable for the general case [37]. (cid:46) Graph Operators: In our evaluation, we model oper- ators from all the classes in Section 2.3. As representa- tives of the distance class, we choose betweenness (bc), edge betweenness (ebc) and closeness centralities (cc) ([32, 10]), three metrics that express how central a vertex or edge is in a graph. (cid:140)e (cid:128)rst two consider the number of shortest paths passing from a vertex or edge while the third is based on the distance between a vertex and all other vertices. From the spectrum class, we choose spec- tral radius (sr) and eigenvector centrality (ec). (cid:140)e (cid:128)rst is de(cid:128)ned as the largest eigenvalue of the adjacency ma- trix of the graph. As a metric, it is associated with the robustness of a network against the spreading of a virus [25]. (cid:140)e second is another measure that expresses ver- tex centrality [7]. It is based on the eigenvectors of the adjacency matrix. Finally, as a connectivity related met- ric we consider PageRank (pr), a centrality measure used for ranking web pages based on popularity [11]. All measures, except spectral radius, are centrality measures expressed at vertex level (edge level in the case of edge betweenness). Since we wish all our measures to be expressed at graph level, we will be using a method a(cid:138)ributed to Freeman [16] to make that generalization. (cid:140)is is a general approach that can be applied to any cen- trality [10], and measures the average di(cid:130)erence in cen- trality between the most central point and all others: (cid:80) i,j∈V c(j)∗ − c(i) V − 1 c(G) = c(G) being the measure at graph level, c(i) the centrality value of the i-th vertex of G and c(j)∗ the largest cen- trality value for all i ∈ V . All the graph operators are implemented in R. We use the R package of the igraph library [13] which con- tains implementations of all the algorithms mentioned. (cid:46) kNN: (cid:140)e only parameter we will have to specify for kNN is k. A(cid:137)er extensive experimentation (omi(cid:138)ed due to space constraints), we have observed that small values of k tend to perform be(cid:138)er. As a result, all our experi- ments are performed with k = 3. (cid:46) Error Metrics: (cid:140)e modeling accuracy of our method is quanti(cid:128)ed using two widely used measures from the literature, i.e., the Median Absolute Percentage Error de- (cid:128)ned as: gi − gi ) gi M dAP E = mediani=1,N (100 where gi = g(Gi) is the i-th actual value of a graph oper- ator and gi the corresponding forecast. (cid:140)e second met- ric we use is the Normalized Root Mean Squared Error, de(cid:128)ned as: (cid:118)(cid:117)(cid:117)(cid:116) 1 N N(cid:88) i=1 nRM SE = 1 c (gi − gi)2 with c being the normalization factor which, in our case, is max(gi), i ∈ [1, N ]. (cid:46) Setup: All experiments are conducted on an Openstack VM with 16 Intel Xeon E312 processors at 2GHz, 32G main memory running Ubuntu Server 16.04.3 LTS with Linux kernel 4.4.0. We implemented our prototype in Go language (v.1.7.6). 3.2 Experiments (cid:46) Modeling Accuracy: To evaluate the accuracy of our approximations, we calculate MdAPE and nRMSE for a randomized 20% of our dataset: For a dataset of 1,000 graphs, 200 will be chosen at random for which the error metrics will be calculated. We vary the sampling ratio p, i.e., the number of graphs for which we actually exe- cute the operator, divided by the total number of graphs in the dataset. (cid:140)e results are displayed in Table 2. Each row represents a combination of a dataset and a graph operator with the corresponding error values for di(cid:130)er- ent values of p between 5% and 20%. (cid:140)e results in Table 2 showcase that our method is ca- pable of modeling di(cid:130)erent classes of graph operators with very good accuracy. Although our approach em- ploys a degree distribution-based similarity measure, we observe that the generated similarity matrix is expressive enough to allow the accurate modeling of distance- and spectrum-related metrics as well, achieving errors well below 10% for most cases. In AS graphs, the M dAP E error is less than 3.2% for all the considered operators when only a mere 5% of the available graphs is exam- ined. Operators such as closeness or eigenvector central- ities display low M dAP E errors in the range of < 8% for all datasets. (cid:140)rough the use of more expressive or combined similarity measures, our method can improve on these results, as we show later in this Section. We also note that the approximation accuracy increases with the sampling ratio. (cid:140)is is expressed by the decrease of both M dAP E and nRM SE when we increase the size of our training set. (cid:140)ese results verify that modeling such graph operators is not only possible, but it can also produce highly accurate models with marginal errors. Speci(cid:128)cally, in the case of the AS dataset, we observe that all the operators are modeled more accurately than in any other real or synthetic dataset. (cid:140)is can be at- tributed to the topology of the AS graphs. (cid:140)ese graphs display a linear relationship between vertex and edge counts. (cid:140)eir clustering coe(cid:129)cient displays very li(cid:138)le variance, suggesting that as the graphs grow in size they keep the same topological structure. (cid:140)is gradual, uni- form evolution of the AS graphs leads to easier modeling of the values of a given graph topology metric. On the other hand, our approach has be(cid:138)er accuracy for degree- than distance-related metrics in the cases of the TW and BA datasets. (cid:140)e similarity measure we use is based on the degree distribution that is only indirectly related to vertex distances. (cid:140)is can be seen, for example, in the case of BA if we compare the modeling error for the betweenness centrality (bc) and PageRank (pr) measures. Overall, we see that eigenvector and closeness central- ities are the two most accurately approximated metrics across all datasets. A(cid:137)er we (cid:128)nd PageRank, spectral ra- dius, betweenness and edge betweenness centralities. Willing to further examine the connection between modeling accuracy and the type of similarity measure used, we have experimented with di(cid:130)erent similarity measures, leading to the inclusion of D-measure and rw- kernel in our evaluation. (cid:140)is has also lead to the devel- opment of the degree-level similarity measures and the combination of similarity matrices in the cases of degree distribution similarity matrix and vertex count similarity matrix. (cid:46) Execution Speedup: Next, we evaluate the gains our method can provide in execution time when compared to the running time of a graph operator being executed for all the graphs of each dataset. Similarity matrix com- putation is a time-consuming step that is executed once for each dataset. Yet, an advantage of our scheme is that it can be reused for di(cid:130)erent graph operators. Conse- quently, time costs can be amortized over di(cid:130)erent op- erators. In order to provide a be(cid:138)er insight, we calculate two types of speedups: One that considers the similar- ity matrix construction from scratch for each operator separately (provided in the Speedup column of Table 2) and one that expresses the average speedup for all six metrics for each dataset, where the similarity matrix has been constructed only once (provided in the Amortized Table 2: Modeling Errors and Execution Speedup for Di(cid:130)erent Sampling Rates MdAPE (%) nRMSE p=5% p=10% p=20% p=5% p=10% p=20% p=5% p=10% p=20% p=5% p=10% Speedup × Amortized Speedup × p=20% 18.0 9.5 4.9 14.8 8.5 4.6 16.3 9.0 4.7 Dataset Metric AS TW BA sr ec bc ebc cc pr sr ec bc ebc cc pr sr ec bc ebc cc pr 1.3 0.1 1.4 3.1 0.4 0.9 16.3 8.0 17.8 29.5 3.3 9.2 3.3 0.4 10.3 10.9 2.4 6.7 1.1 0.1 1.2 2.7 0.4 0.8 15.3 7.7 17.5 29.8 3.0 7.7 1.8 0.3 10.1 9.3 2.2 6.1 0.9 0.0 1.1 2.4 0.3 0.7 14.7 7.7 16.8 28.6 2.9 7.2 0.9 0.3 9.6 8.5 2.1 5.9 0.05 0.01 0.04 0.04 0.01 0.05 0.10 0.14 0.16 0.12 0.10 0.07 0.04 0.01 0.10 0.10 0.04 0.06 0.03 0.00 0.03 0.04 0.01 0.04 0.10 0.14 0.15 0.12 0.10 0.06 0.03 0.01 0.05 0.09 0.04 0.05 0.02 0.00 0.03 0.04 0.01 0.03 0.10 0.13 0.14 0.12 0.09 0.05 0.03 0.01 0.02 0.01 0.03 0.05 6.4 5.7 15.7 17.3 14.0 5.7 13.3 13.1 13.0 13.5 13.0 13.2 5.6 3.7 12.6 13.6 9.9 3.6 3.8 4.5 8.8 9.3 8.2 4.4 8.0 7.9 7.8 8.0 7.9 7.9 4.4 3.1 7.7 8.1 6.6 3.0 3.3 3.1 4.7 4.8 4.5 3.1 4.4 4.4 4.4 4.4 4.4 4.4 3.0 2.4 4.4 4.5 4.0 2.3 Speedup column of Table 2). For example, in the case of the AS dataset and for the spectral radius metric, our ap- proach is 6.4× faster when using 5% sampling ratio than the computation of the spectral radius for all the graphs of AS. Additionally, if we utilize the same matrix for all six operators, this increases the speedup to 18×. (cid:140)e observed results highlight that our methodology is not only capable of providing models of high quality, but also does so in a time-e(cid:129)cient manner. A closer exam- ination of the Speedup columns shows that our method is particularly e(cid:129)cient for complex metrics that require more computation time (as in the ebc and cc cases for all datasets). (cid:140)e upper bound of the theoretically antic- ipated speedup equals 1 , i.e., in the p = 5% case each p operator runs on 20 times fewer graphs than the exhaus- tive modeling, without taking into account the time re- quired for the similarity matrix and the training of the kNN model. Interestingly, the Amortized Speedup col- umn indicates that when the procedure of constructing the similarity matrix is amortized to the six operators under consideration, the achieved speedup is very close to the theoretical one. (cid:140)is is indeed the case for the AS and BA datasets that comprise the largest graphs, in terms of number of vertices: For all p values, the amor- In the case of tized speedup closely approximates 1 p the TW dataset which consists of much smaller graphs and, hence, the time dedicated to the similarity matrix estimation is relatively larger than the previous cases, we observe that the achieved speedup is also sizable. In any case, the capability of reusing the similarity matrix, which is calculated on a per-dataset rather than on a per- operator basis, enables our approach to scale and be more . e(cid:129)cient as the number and complexity of graph opera- tors increases. (cid:46) Comparing Similarity Measures: (cid:140)e results of the similarity measure comparisons, for the AS, TW and BA datasets, are displayed in Figures 3, 4 and 5, respectively, where M dAP E is used to express the modeling error. For the TW dataset we compare six similarity measures: (cid:140)e degree distribution + levels measure (for levels equal from 0 to 2), a combination of level-0 degree distribution with vertex count (denoted by level-0 + size), D-measure and the Random Walk Kernel based similarity measure (denoted by rw-kernel). In the cases of AS and BA we do not include D-measure, since it was not possible to compute it, for the graphs of those datasets, because of its running time. In addition for BA we do not include rw-kernel for the same reason. (cid:140)e results indicate the impact that the choice of similarity measure has on mod- eling accuracy. A more suitable to the modeled opera- tor and detailed similarity measure is more sensitive to topology di(cid:130)erences and can lead to be(cid:138)er operator mod- eling. Focusing on the TW dataset, we observe that in all (cid:128)g- ures, with the exception of PageRank, the degree distri- bution + levels similarity measure, for a number of levels, can model an operator more accurately than the simple degree distribution-based, e(cid:130)ectively reducing the errors reported in Table 2. Indeed, the addition of more levels to the degree distribution incorporates more information about the connectivity of each vertex. (cid:140)is additional topological insights contribute positively to be(cid:138)er esti- mate the similarity of two graphs. For instance, this al- lows the MdAPE error to drop from 29.5% to about 15% (a) Spectral Radius (b) Eigenvector C. (c) Betweenness C. (d) Edge Betweenness C. (e) Closeness C. (f) PageRank Figure 3: Similarity Metrics Comparison (AS) (a) Spectral Radius (b) Eigenvector C. (c) Betweenness C. (d) Edge Betweenness C. (e) Closeness C. (f) PageRank Figure 4: Similarity Metrics Comparison (TW) (a) Spectral Radius (b) Eigenvector C. (c) Betweenness C. (d) Edge Betweenness C. (e) Closeness C. (f) PageRank Figure 5: Similarity Metrics Comparison (BA) 0 0.02 0.04 0.05 0.1 0.15 0.2 0.25 0.3 0.35MdAPESampling Ratiolevel-0level-1level-2level-0+sizerw-kernel 0 0.02 0.04 0.05 0.1 0.15 0.2 0.25 0.3 0.35MdAPESampling Ratiolevel-0level-1level-2level-0+sizerw-kernel 0 0.02 0.04 0.05 0.1 0.15 0.2 0.25 0.3 0.35MdAPESampling Ratiolevel-0level-1level-2level-0+sizerw-kernel 0 0.02 0.04 0.05 0.1 0.15 0.2 0.25 0.3 0.35MdAPESampling Ratiolevel-0level-1level-2level-0+sizerw-kernel 0 0.02 0.04 0.05 0.1 0.15 0.2 0.25 0.3 0.35MdAPESampling Ratiolevel-0level-1level-2level-0+sizerw-kernel 0 0.02 0.04 0.05 0.1 0.15 0.2 0.25 0.3 0.35MdAPESampling Ratiolevel-0level-1level-2level-0+sizerw-kernel 0 0.1 0.2 0.3 0.4 0.5 0.6 0.05 0.1 0.15 0.2 0.25 0.3 0.35MdAPESampling Ratiolevel-0level-1level-2level-0+sized-simrw-kernel 0 0.1 0.2 0.3 0.4 0.5 0.6 0.05 0.1 0.15 0.2 0.25 0.3 0.35MdAPESampling Ratiolevel-0level-1level-2level-0+sized-simrw-kernel 0 0.1 0.2 0.3 0.4 0.5 0.6 0.05 0.1 0.15 0.2 0.25 0.3 0.35MdAPESampling Ratiolevel-0level-1level-2level-0+sized-simrw-kernel 0 0.1 0.2 0.3 0.4 0.5 0.6 0.05 0.1 0.15 0.2 0.25 0.3 0.35MdAPESampling Ratiolevel-0level-1level-2level-0+sized-simrw-kernel 0 0.1 0.2 0.3 0.4 0.5 0.6 0.05 0.1 0.15 0.2 0.25 0.3 0.35MdAPESampling Ratiolevel-0level-1level-2level-0+sized-simrw-kernel 0 0.1 0.2 0.3 0.4 0.5 0.6 0.05 0.1 0.15 0.2 0.25 0.3 0.35MdAPESampling Ratiolevel-0level-1level-2level-0+sized-simrw-kernel 0 0.02 0.04 0.06 0.08 0.1 0.12 0.05 0.1 0.15 0.2 0.25 0.3MdAPESampling Ratiolevel-0level-1level-2level-0+size 0 0.02 0.04 0.06 0.08 0.1 0.12 0.05 0.1 0.15 0.2 0.25 0.3MdAPESampling Ratiolevel-0level-1level-2level-0+size 0 0.02 0.04 0.06 0.08 0.1 0.12 0.05 0.1 0.15 0.2 0.25 0.3 0.35MdAPESampling Ratiolevel-0level-1level-2level-0+size 0 0.02 0.04 0.06 0.08 0.1 0.12 0.05 0.1 0.15 0.2 0.25 0.3MdAPESampling Ratiolevel-0level-1level-2level-0+size 0 0.02 0.04 0.06 0.08 0.1 0.12 0.05 0.1 0.15 0.2 0.25 0.3MdAPESampling Ratiolevel-0level-1level-2level-0+size 0 0.02 0.04 0.06 0.08 0.1 0.12 0.05 0.1 0.15 0.2 0.25 0.3MdAPESampling Ratiolevel-0level-1level-2level-0+size Finally, we observe that, in speci(cid:128)c cases, such as PageRank (Figure 4f), enhancing the degree distribution with degrees of more levels introduces information that is interpreted as noise during modeling. PageRank is bet- ter modeled with the simple degree distribution as a simi- larity measure. As such, we argue that for a given dataset and graph operator, experimentation is required to (cid:128)nd the number of levels that give the best tradeo(cid:130) between accuracy and execution time. We next concentrate on the e(cid:130)ect of the combination of degree distribution with vertex count in the model- ing accuracy. We note that the vertex count contributes positively in the modeling of distance-related metrics while having a neutral or negative impact on degree- and spectrum-related metrics. (cid:140)is is a(cid:138)ributed to the exis- tence of, at least, a mild correlation, between vertex count and bc, ebc and cc [26]. For our least accurately approx- imated task, edge betweenness centrality, employing the combination of measures results in a more than 6× de- crease in error. when utilizing a level-2 similarity for edge betweenness centrality and p = 5%. Examining the modeling quality, we observe that it increases but only up to a certain point, in relation to the topology of the graphs in the dataset. For example, since TW comprises of ego graphs, all the degrees of level > 2 are zero, since there exist no vertices with distance greater than 2; therefore, employing more levels does not contribute any additional information about the topology of the graphs when computing their similarity. For D-measure, our experiments show that, for distance-related metrics it performs at least as good as the degree distribution + levels similarity measures for a given level, with the notable exception of the PageRank case. On the other hand, the degree distribution can be su(cid:129)- ciently accurate for degree- or spectrum-related metrics. As D-measure is based on distance distributions between vertices, having good accuracy for distance-related mea- sures is something to be expected. However, degree dis- tribution + levels measures exhibit comparable accuracy for distance-related metrics as well. A good example of the e(cid:130)ectiveness of D-measure is shown in the case of closeness centrality that involves all-pairs node dis- tance information directly incorporated in D-measure as we have seen in Section 3.1. In Figure 4e we observe that by adding levels we get be(cid:138)er results, vertex count con- tributes into even be(cid:138)er modeling but D-measure gives be(cid:138)er approximations. Yet, our methods' errors are al- ready very small (less than 3%) in this case. Consider- ing the rw-kernel similarity measure, we observe that it performs poorly for most of the modeled operators. Al- though its modeling accuracy is comperable to the degree distribution + levels similarity measures for some opera- tors, we (cid:128)nd that for a certain level or in combination with vertex count a degree distribution-based measure has be(cid:138)er accuracy. Notably, rw-kernel has low accuracy for degree and distance related operators while perform- ing comperably in the case of spectrum operators. Identifying betweenness centrality as one of the hard- est operators to model accurately, we note that, for the AS and BA datasets, the approximation error is below 12% and that the degree distribution + levels measures further improve on it for both datasets. Compared to TW (Fig. 4), we observe that the level-2 similarity measure provides be(cid:138)er results for AS and BA but not TW, something we a(cid:138)ribute to the fact that TW consists of ego graphs with their level-2 degree being equal to zero. Finally, it is ex- pected that level-0 + size for BA to be no di(cid:130)erent than plain level-0 since all the graphs in BA have the same ver- tex count by construction. Figure 6: Execution Time (sec) Although the above similarity measures are compara- ble in modeling accuracy, they are not in execution time. A comparison in computation time for di(cid:130)erent levels of the degree distribution + levels similarity measure is pre- sented in Figure 6. In the case of D-measure, the actual execution time is presented for the TW dataset, since it was prohibitively slow to compute it for the other two datasets. For the remaining two datasets, we have com- puted D-measure on a random number of pairs of graphs and then projected the mean computation time to the number of comparisons performed by our method for each dataset. Our results show that the overhead from level-0 to level-1 is comparable for all the datasets. However, that is not the case for level-2. (cid:140)e higher the level, the more in(cid:131)uential the degree of the vertices becomes in the exe- cution time. Speci(cid:128)cally, while we (cid:128)nd level-0 to be 3.2× faster than level-2 for TW, we observe that in the case of AS and BA it is 19× and 76× faster. (cid:140)e computation of the D-measure and the rw-kernel, on the other hand, are orders of magnitude slower, i.e., we (cid:128)nd level-0 to be about 385K times faster than D-measure for the TW dataset, while it is 273K and 933K times faster for the BA and AS datasets, respectively. Given the di(cid:130)erence in modeling quality between the presented similarity func- tions, we observe a clear tradeo(cid:130) between quality of re- 1102104106ASTWBAExecution Time (sec)level-0level-1level-2d-simrw-kernel (a) AS (p = 15%) (b) TW (p = 10%) (c) BA10k (p = 3%) Figure 7: All-Pairs Similarities vs Clustering (d) Similarity Computations sults and execution time in the context of our method. (cid:46) Similarity Matrix Computation Speedup: In order to evaluate the e(cid:130)ectiveness of the similarity matrix op- timization we outlined in section 2.2, in Fig. 7 we present experimental results both in terms of modeling accuracy and speedup. As we aim at evaluating the scalability of our method we introduce two larger synthetic datasets BA10k and BA50k. (cid:140)ey are both created with the same se(cid:138)ings used for the BA dataset and contain 10k and 50k graphs respectively. In Fig. 7a, 7b and 7c we compare the modeling er- ror between all-pairs similarity matrix (level-0) and clus- tered similarity matrix (kmedoids) for the AS, TW and BA10k datasets. As we mentioned in Section 3.2, we cal- culate MdAPE and nRMSE for a randomized 20% of our datasets. For each dataset we use a sampling ratio p based on the parameter k = 3 of kNN and the number of clus- ters we intend to create which we set to √ N. (cid:140)us, for a dataset of 10k graphs we create 100 clusters and re- quire 300 graph samples, therefore we set the sampling ratio to 3%. (cid:140)e graph samples are randomly chosen en- suring that we have at least k from each cluster. In (cid:128)g- ure 7d we present speedups in the number of similarity computations performed in each of the above cases for all datasets. We observe that the clustering optimization adds at most a 3% error in the case of TW while achiev- ing a 10× speedup when we use 30 clusters. Focusing on the BA10k and BA50k datasets, we observe marginal er- ror increases and speedups up to 15×. Consequently, we argue that this optimization allows our method to scale e(cid:129)ciently to large graph datasets. 4 Related Work Our work relates to the actively researched areas of graph similarity, graph analytics and machine learning. 4.1 Graph Similarity (cid:140)e problem of determining the degree of similarity be- tween two graphs (or networks) has been well studied. (cid:140)e available techniques for quantifying graph similar- ity can be classi(cid:128)ed into three main categories ([29, 40]): (cid:46) Graph Isomorphism - Edit Distance: Two graphs are considered similar if they are isomorphic, i.e., there is a bijection between the vertex sets of the two graphs such that two vertices of one graph are adjacent if and only if their images are also adjacent [8]. A more relaxed approach is to consider the problem of subgraph isomor- phism where one graph is isomorphic to a subgraph of the other. A generalization of the graph isomorphism problem is expressed through the Edit Distance, i.e., the number of operations, such as additions or removals of edges or nodes, that have to be performed in order to transform one graph to the other [35]. (cid:140)e drawback of approaches in this category is that the graph isomor- phism problem is hard to compute. (cid:140)e fastest algorithm to solve it runs in quasi-polynomial time with previous solutions being of exponential complexity [3]. Consider- ing our method, a quasi-polynomial similarity measure is very expensive, since we have to compute all-pairs simi- larity scores for a given graph dataset. (cid:46) Iterative Methods: (cid:140)is category of graph similar- ity algorithms is based on the idea that two vertices are similar if their neighborhoods are similar. Applying this idea iteratively over the entire graph can produce a global similarity score when the process converges. Based on this iterative approach there are algorithms like Sim- Rank [27] or the algorithm proposed by Zager et al. [40] that compute similarities between graphs or graph nodes. Such algorithms compare graphs based on their topology, thus their performance depends on graph size. Consider- ing our case, the e(cid:129)ciency of our method would depend on the size of the graphs we compare. Alternatively, we choose to map graphs to feature vectors and base our sim- ilarity scores on vector comparisons. Since the feature vectors are of low dimensionality compared to graphs, this approach is more e(cid:129)cient. (cid:46) Feature Vector Extraction: (cid:140)ese approaches are based on the idea that similar graphs share common properties such as degree distribution, diameter, clus- tering coe(cid:129)cient, etc. Methods in this class represent graphs as feature vectors. To assess the degree of similar- ity between graphs, statistical tools are used to compare their feature vectors instead. Such methods are not as computationally demanding and thus scale be(cid:138)er. Draw- 0 0.05 0.1 0.15 0.2 0.25 0.3 0.35srecbcebcccprMdAPElevel-0kmedoids 0 0.05 0.1 0.15 0.2 0.25 0.3 0.35srecbcebcccprMdAPElevel-0kmedoids 0 0.05 0.1 0.15 0.2 0.25 0.3 0.35srecbcebcccprMdAPElevel-0kmedoids 0 5 10 15 20TW (30)BA (30)AS (30)BA10K (100)BA50K (250)Speedup (x) ing from this category of measures, in our work, we base our graph similarity computations on comparing degree distributions. (cid:46) Graph Kernels: A di(cid:130)erent approach to graph sim- ilarity comes from the area of machine learning where kernel functions can be used to infer knowledge about samples. A kernel can be thought of as a measure of similarity between two objects which satis(cid:128)es two math- ematical properties, it is symmetric and positive semi- de(cid:128)nite. Graph kernels are kernel functions constructed on graphs or graph nodes for comparing graphs or nodes respectively. Extensive research on this area (e.g., [20, 18]) has resulted in many kernels based on walks, paths, subgraphs, substree pa(cid:138)erns, etc. While computationally more expensive than feature vector extraction similarity methods, they provide a good baseline for our modeling accuracy evaluation. 4.2 Graph Analytics & Machine Learning Although graph analytics is a very thoroughly re- searched area, there exist few cases where machine learn- ing techniques are used. On the subject of graph sum- marization, a new approach is based on node representa- tions that are learned automatically from the neighbor- hood of a vertex. Such representations are a mapping of vertices to a low-dimensional space of features that aims at capturing their neighborhood structure. Works in this direction [21] focus on learning node representa- tions and using those for graph summarization and/or compression. Node representations are also applicable in computing node or graph similarities as seen in [21] and [33]. However, we do not (cid:128)nd works employing machine learning techniques in the (cid:128)eld of graph mining through graph topology metric computations. Most of the re- search on that (cid:128)eld focuses on approximation algorithms (e.g., [34, 15]). 5 Conclusion As the Graph Analytics landscape evolves, an increas- ing number of graph operators are required to be exe- cuted over large graph datasets in order to identify those of "high interest". To this end, we present an operator- agnostic modeling methodology which leverages similar- ity between graphs. (cid:140)is knowledge is used by a kNN classi(cid:128)er to model a given operator allowing scientists to predict operator output for any graph without having to actually execute the operator. We propose an intuitive, yet powerful class of similarity measures that e(cid:129)ciently capture graph relations. Our thorough evaluation indi- cates that modeling a variety of graph operators is not only possible, but it can also provide results of very high quality at considerable speedups. (cid:140)is is especially true when adopting a lightweight, yet highly e(cid:130)ective similar- ity measure as those introduced by our work. Finally, our approach appears to present similar results to state-of- the-art similarity measures, such as D-measure, in terms of quality, but requires orders of magnitude less execu- tion time. References [1] F. J. Aherne, N. A. (cid:140)acker, and P. I. Rocke(cid:138). (cid:140)e bhat- tacharyya metric as an absolute similarity measure for fre- quency coded data. Kybernetika, 34(4):363 -- 368, 1998. [2] D. Arthur and S. Vassilvitskii. k-means++: the advantages In Proceedings of the Eighteenth An- of careful seeding. nual ACM-SIAM Symposium on Discrete Algorithms, SODA 2007, New Orleans, Louisiana, USA, January 7-9, 2007, pages 1027 -- 1035, 2007. [3] L. Babai. Graph isomorphism in quasipolynomial time [extended abstract]. In Proceedings of the 48th Annual ACM SIGACT Symposium on (cid:138)eory of Computing, STOC 2016, Cambridge, MA, USA, June 18-21, 2016, pages 684 -- 697, 2016. [4] A.-L. Barab´asi and R. Albert. Emergence of scaling in ran- dom networks. Science, 286(5439):509 -- 512, 1999. [5] J. L. Bentley. Multidimensional binary search trees used for associative searching. Commun. ACM, 18(9):509 -- 517, 1975. [6] A. Bha(cid:138)acharyya. On a measure of divergence between two statistical populations de(cid:128)ned by their probability distributions. Bulletin of Calcu(cid:136)a Mathematical Society, 35(1):99 -- 109, 1943. [7] P. Bonacich. Power and centrality: A family of measures. American Journal of Sociology, 92(5):1170 -- 1182, 1987. [8] A. Bondy and U. Murty. Graph (cid:138)eory. Springer London, 2011. [9] G. Bounova and O. de Weck. Overview of metrics and their correlation pa(cid:138)erns for multiple-metric topology anal- ysis on heterogeneous graph ensembles. Phys. Rev. E, 85:016117, 2012. [10] U. Brandes and T. Erlebach. Network Analysis: Method- ological Foundations (Lecture Notes in Computer Science). Springer-Verlag New York, Inc., 2005. [11] S. Brin and L. Page. (cid:140)e anatomy of a large-scale hypertex- tual web search engine. Computer Networks, 30(1-7):107 -- 117, 1998. [12] T. H. Cormen, C. E. Leiserson, R. L. Rivest, and C. Stein. Introduction to Algorithms, (cid:138)ird Edition. (cid:140)e MIT Press, 2009. [13] G. Csardi and T. Nepusz. (cid:140)e igraph so(cid:137)ware package for complex network research. InterJournal, Complex Sys- tems:1695, 2006. [14] L. da F. Costa, F. A. Rodrigues, G. Travieso, and P. R. V. Boas. Characterization of complex networks: A survey of measurements. Advances in Physics, 56(1):167 -- 242, 2007. [15] D. Eppstein and J. Wang. Fast approximation of centrality. J. Graph Algorithms Appl., 8:39 -- 45, 2004. [16] L. C. Freeman. A set of measures of centrality based on betweenness. Sociometry, 40(1):35 -- 41, 1977. [17] A. Gandomi and M. Haider. Beyond the Hype. Int. J. Inf. Manag., 35(2):137 -- 144, 2015. [18] T. Gartner. A survey of kernels for structured data. SIGKDD Explorations, 5(1):49 -- 58, 2003. [19] T. Gartner, P. A. Flach, and S. Wrobel. On graph kernels: Hardness results and e(cid:129)cient alternatives. In Computa- tional Learning (cid:138)eory and Kernel Machines, 16th Annual Conference on Computational Learning (cid:138)eory and 7th Ker- nel Workshop, COLT/Kernel 2003, Washington, DC, USA, August 24-27, 2003, Proceedings, pages 129 -- 143, 2003. [20] S. Ghosh, N. Das, T. Gonc¸alves, P. (cid:139)aresma, and M. Kundu. (cid:140)e journey of graph kernels through two decades. Computer Science Review, 27:88 -- 111, 2018. [21] A. Grover and J. Leskovec. node2vec: Scalable feature learning for networks. In Proceedings of the 22nd ACM SIGKDD International Conference on Knowledge Discovery and Data Mining, San Francisco, CA, USA, August 13-17, 2016, pages 855 -- 864, 2016. [22] A. Halevy, P. Norvig, and F. Pereira. (cid:140)e unreasonable e(cid:130)ectiveness of data. IEEE Intelligent Systems, 24(2):8 -- 12, 2009. [23] T. Hastie, R. Tibshirani, and J. Friedman. (cid:138)e Elements of Statistical Learning: Data Mining, Inference, and Prediction, Second Edition. Springer New York. [24] J. M. Hern´andez and P. V. Mieghem. Classi(cid:128)cation of graph metrics. pages 1 -- 20, 2011. [25] A. Jamakovic, R. E. Kooij, P. V. Mieghem, and E. R. van Dam. Robustness of networks against viruses: the role of the spectral radius. In 2006 Symposium on Communica- tions and Vehicular Technology, pages 35 -- 38, 2006. [26] A. Jamakovic and S. Uhlig. On the relationships between NHM, topological measures in real-world networks. 3(2):345 -- 359, 2008. [27] G. Jeh and J. Widom. Simrank: A measure of structural- context similarity. In Proceedings of the Eighth ACM SIGKDD International Conference on Knowledge Discovery and Data Mining, pages 538 -- 543. ACM, 2002. [28] L. Kaufmann and P. Rousseeuw. Clustering by means of medoids. pages 405 -- 416, 01 1987. [29] D. Koutra, A. Parikh, A. Ramdas, and J. Xiang. Algorithms for graph similarity and subgraph matching. Technical Re- port Carnegie-Mellon-University, 2011. [30] J. Leskovec and A. Krevl. large network dataset collection. stanford.edu/data, June 2014. SNAP Datasets: Stanford http://snap. [31] J. Leskovec and R. Sosic. Snap: A general-purpose net- work analysis and graph-mining library. ACM Transac- tions on Intelligent Systems and Technology (TIST), 8(1):1, 2016. [32] M. E. J. Newman and M. Girvan. ating community structure in networks. 69(2):026113, 2004. Finding and evalu- Phys. Rev. E, [33] L. F. R. Ribeiro, P. H. P. Saverese, and D. R. Figueiredo. struc2vec: Learning node representations from structural identity. In Proceedings of the 23rd ACM SIGKDD Interna- tional Conference on Knowledge Discovery and Data Min- ing, Halifax, NS, Canada, August 13 - 17, 2017, pages 385 -- 394, 2017. [34] M. Riondato and E. M. Kornaropoulos. Fast approximation of betweenness centrality through sampling. Data Min. Knowl. Discov., 30(2):438 -- 475, 2016. [35] A. Sanfeliu and K. Fu. A distance measure between at- tributed relational graphs for pa(cid:138)ern recognition. IEEE Trans. Systems, Man, and Cybernetics, 13(3):353 -- 362, 1983. [36] T. A. Schieber, L. Carpi, A. D´ıaz-Guilera, P. M. Pardalos, C. Masoller, and M. G. Rave(cid:138)i. (cid:139)anti(cid:128)cation of network structural dissimilarities. Nature communications, 8:13928, 2017. [37] M. Sugiyama and K. M. Borgwardt. Halting in random walk kernels. In Advances in Neural Information Processing Systems 28: Annual Conference on Neural Information Pro- cessing Systems 2015, December 7-12, 2015, Montreal, (cid:137)e- bec, Canada, pages 1639 -- 1647, 2015. [38] S. V. N. Vishwanathan, N. N. Schraudolph, R. Kondor, and Journal of Machine K. M. Borgwardt. Graph kernels. Learning Research, 11:1201 -- 1242, 2010. [39] D. Yan, Y. Bu, Y. Tian, A. Deshpande, and J. Cheng. Big Graph Analytics Systems. In SIGMOD, 2016. [40] L. A. Zager and G. C. Verghese. Graph similarity scoring and matching. Appl. Math. Le(cid:136)., 21(1):86 -- 94, 2008.
1303.3751
1
1303
2013-03-15T12:17:10
Friend or Foe? Fake Profile Identification in Online Social Networks
[ "cs.SI", "physics.soc-ph" ]
The amount of personal information unwillingly exposed by users on online social networks is staggering, as shown in recent research. Moreover, recent reports indicate that these networks are infested with tens of millions of fake users profiles, which may jeopardize the users' security and privacy. To identify fake users in such networks and to improve users' security and privacy, we developed the Social Privacy Protector software for Facebook. This software contains three protection layers, which improve user privacy by implementing different methods. The software first identifies a user's friends who might pose a threat and then restricts this "friend's" exposure to the user's personal information. The second layer is an expansion of Facebook's basic privacy settings based on different types of social network usage profiles. The third layer alerts users about the number of installed applications on their Facebook profile, which have access to their private information. An initial version of the Social Privacy Protection software received high media coverage, and more than 3,000 users from more than twenty countries have installed the software, out of which 527 used the software to restrict more than nine thousand friends. In addition, we estimate that more than a hundred users accepted the software's recommendations and removed at least 1,792 Facebook applications from their profiles. By analyzing the unique dataset obtained by the software in combination with machine learning techniques, we developed classifiers, which are able to predict which Facebook profiles have high probabilities of being fake and therefore, threaten the user's well-being. Moreover, in this study, we present statistics on users' privacy settings and statistics of the number of applications installed on Facebook profiles...
cs.SI
cs
Friend or Foe? Fake Profile Identification in Online Social Networks Michael Fire, Dima Kagan, Aviad Elyashar, and Yuval Elovici∗ Telekom Innovation Laboratories at Ben-Gurion University of the Negev Department of Information Systems Engineering, Ben Gurion University 3 1 0 2 r a M 5 1 ] I S . s c [ 1 v 1 5 7 3 . 3 0 3 1 : v i X r a Abstract The amount of personal information unwillingly exposed by users on online social networks is staggering, as shown in recent research. Moreover, recent reports indicate that these networks are infested with tens of millions of fake users profiles, which may jeopardize the users' security and privacy. To identify fake users in such networks and to improve users' security and privacy, we developed the Social Privacy Protector software for Facebook. This software contains three protection layers, which improve user privacy by implementing different methods. The software first identifies a user's friends who might pose a threat and then restricts this "friend's" exposure to the user's personal information. The second layer is an expansion of Facebook's basic privacy settings based on different types of social network usage profiles. The third layer alerts users about the number of installed applications on their Facebook profile, which have access to their private information. An initial version of the Social Privacy Protection software received high media cover- age, and more than 3,000 users from more than twenty countries have installed the software, out of which 527 used the software to restrict more than nine thousand friends. In addition, we estimate that more than a hundred users accepted the software's recommendations and removed at least 1,792 Facebook applications from their profiles. By analyzing the unique dataset obtained by the software in combination with machine learning techniques, we developed classifiers, which are able to predict which Facebook profiles have high probabilities of being fake and therefore, threaten the user's well-being. Moreover, in this study, we present statistics on users' privacy settings and statistics of the number of applications installed on Facebook profiles. Both statistics are obtained by the Social Privacy Protector software. These statistics alarmingly demonstrate how exposed Facebook users information is to both fake profile attacks and third party Facebook applications. Keywords. Social Network Security and Privacy, Fake Profiles, Online Social Networks, Facebook, Supervised Learning, Facebook Application, Facebook Friends Statistics, Facebook Applications Statistics, Facebook Users Privacy Settings. 1 Introduction In recent years, online social networks have grown rapidly and today offer individuals endless possi- bilities for publicly expressing themselves, communicating with friends, and sharing information with people across the world. A recent survey [28] estimated that 65% of adult internet users use online social network sites, such as Twitter [40], LinkedIn [26], Google+ [18], and Facebook [9]. As of October 2012, the Facebook social network has more than one billion active users monthly [13]. On average, Facebook users have 138 friends and upload more than 219 billion pictures onto Facebook [13]. More- over, according to the Nielsen "Social Media Report" [31], American Internet users spent more than 53.5 billion minutes on Facebook in the month of May 2011, making Facebook the leading web-brand in the United-States. Due to the friendly nature of Facebook, users tend to disclose many personal details about them- selves and about their connections. These details can include date of birth, personal pictures, work place, email address, high school name, relationship statuses, and even phone numbers. Moreover, ∗Email: {mickyfi, kagandi,aviade, [email protected]} 1 Bosmaf et al. [4], discovered that an average of 80% of studied Facebook users accepted friend re- quests from people they did not know if they shared more than 11 mutual friends. In many cases, accepting friend requests from strangers may result in the exposure of a user's personal information to third parties. Additionally, personal information of Facebook users can be exposed to third party Facebook applications [8]. Another privacy concern deals with existing privacy settings, for which the majority of Facebook users do not match the security expectations [27]. These results indicate that many users accidently or unknowingly publish private information leaving them more exposed than they assumed. If a user's personal information is disclosed to a malicious third party, it can be used to threaten the well-being of the user both online and in the real world. For example, a malicious user can use the gained personal information and send customized spam messages to a user in an attempt to lure such users onto malicious websites [39], or blackmail them into transferring money to the attacker's account [30]. To cover their tracks, social network attackers may use fake profiles. In fact, the number of fake profiles on Facebook can be counted in the tens of millions. According to a recent report [12], Facebook estimates that 8.7% (83.09 million), of its accounts do not belong to real profiles. Moreover, Facebook also estimates that 1.5% (14.32 million), of its accounts are "undesirable accounts", which belong to users who may deliberately spread undesirable content, such as spam messages and malicious links, and threaten the security and privacy of other Facebook users. In this study, we present the Social Privacy Protector software for protecting user privacy on Facebook (otherwise referred to as SPP). The SPP software consists of two main parts, namely, a Firefox add-on and a Facebook application. The two parts provide Facebook users with three different layers of protection. The first layer, which is part of the Firefox add-on, enables Facebook users to easily control their profile privacy settings by simply choosing the most suitable profile privacy settings with just one click. The second layer, which is also part of the software Firefox add-on, notifies users of the number of applications installed on their profile which may impose a threat to their privacy. The third layer, a Facebook application, analyzes a user's friends list. By using simple heuristics (see Section 4.1), the application identifies which friends of a user are suspected as fake profiles and therefore impose a threat on the user's privacy. The application presents a convenient method for restricting the access of fake profiles to a user's personal information without removing them from the user's friends list. At the end of June 2012, we launched an initial version of the SPP software as a "free to use software" [14, 15] and received massive media coverage with hundreds of online articles and interviews in leading blogs and news websites, such as Fox news [3] and NBC news [32]. Due to the media coverage, in less than four months, 3,017 users from more than twenty countries installed the SPP Facebook application, 527 of which used the SPP Facebook application to restrict 9,005 friends1. Moreover, at least 1,676 users installed the Firefox add-on out of which we estimate that 111 users used the add-on recommendation and removed more than 1,792 Facebook applications from their profiles (see Section 5.1). In addition, the add-on also succeeded in collecting the Facebook privacy settings of 67 different Facebook users. To our great surprise many of the SPP application users used the application to not only remove users that were recommended for removal, but to also manually search and restrict them by name, specific friends that have a higher likelihood of having profiles that belong to real people. The removal of real profiles also assists us in studying and constructing classifiers that identify real profiles recom- mended for restriction. The collected data obtained from SPP users gave us a unique opportunity to learn more about user privacy on online social networks in general, and on Facebook in particular. Also, by using the unique data obtained from users restricting their Facebook friends, as well as by implementing machine learning techniques, we developed classifiers, which can identify user's friends that are recommended for restriction (see Section 4.2). Our classifiers presented an AUC of up to 0.948, precision at 200 of up to 98%, and an average users precision at 10 of up to 24% (see Section 5). Furthermore, these types of classifiers can also be used by online social network administrators to 1Due to the unexpected massive downloads and usage of the application our servers did not succeeded in supporting the large amount of users at once. Moreover, in our initial version, the SPP Facebook application did not support all the existing web browsers. Therefore, many users who installed the SPP software did not have the possibility to use it on demand. 2 identify and remove fake profiles from the online social network. In this study we also present statistics on Facebook user privacy settings, which were obtained by the SPP Add-on. These statistics demonstrate how exposed Facebook users' personal information is to fake profile attacks and third party applications (see Section 5.3). For example, we show that out of 1,676 examined Facebook users, 10.68% have more than a hundred Facebook applications installed on their profile, and 30.31% of the users have at least 40 Facebook applications installed. Moreover, out of 67 collected users' privacy settings the majority of the user's personal information is set up to be exposed to friends leaving the user's personal information exposed to fake friends. The remainder of this paper is organized as follows. In Section 2, we provide an overview of various related solutions, which better help protect the security and privacy of social network users. In addition, we also present an overview of similar studies, which used machine learning techniques to predict user properties, such as predicting users' links in social networks. In Section 3, we describe the SPP software architecture in detail. In Section 4, we describe the methods and experiments used in this study. We describe the initial deployment of the SPP software and the methods used for the construction and evaluation of our machine learning classifiers. In Section 5, we present the results of our study, which include an evaluation of our classifiers and different users' privacy statistics obtained by the SPP software. In Section 6, we discuss the obtained results. Lastly, in Section 7, we present our conclusions from this study and offer future research directions. 2 Related Work 2.1 Online Social Network Security and Privacy In recent years, due to the increasing number of privacy and security threats on online social network users, social network operators, security companies, and academic researchers have proposed various solutions to increase the security and privacy of social network users. Social network operators attempt to better protect their users by adding authentication processes to ensure that a registered user represents a real live person [22]. Many social network operators, like Facebook, also offer their users a configurable user privacy setting that enables users to secure their personal data from other users in the network [27, 29]. Additional protection may include a shield against hackers, spammers, socialbots, identity cloning, phishing, and many other threats. For example, Facebook users have an option to report users in the network who harass other users in the network [11]. In addition, Facebook also developed and deployed an Immune System, which aims to protect its user from different online threats [38]. Many commercial and open source products, such as Checkpoint's SocialGuard [44], Websense's Defensio [7], UnitedParents [41], RecalimPrivacy [36], and PrivAware application [33], offer online social network users tools for better protecting themselves. For example, the Websense's Defensio software aims to protect its users from spammers, adult content, and malicious scripts on Facebook. In recent years, several published academic studies have proposed solutions for various social net- work threats. DeBarr and Wechsler [6] used the graph centrality measure to identify spammers. Wang [42] presented techniques to classify spammers on Twitter based on content and graph features. Stringhini et al. [39] presented a solution for detecting spammers in social networks by using "honey- profiles". Egele et al. [8] presented PoX, an extension for Facebook, which makes all requests for private data explicit to the user. Yang et al. [43] presented a method to identify fake profiles by analyzing dif- ferent features, such as links' creation timestamps, and friend requests frequency. Anwar and Fong [2] presented the Reflective Policy Assessment tool, which aids users in examining their profiles from the viewpoint of another user in the network. Rahman et al. [34] presented the MyPageKeeper Facebook application, which aims to protect Facebook users from damaging posts on the user's Facebook wall. In a later study [35], Rahman et al. also presented the FRAppE application for detecting malicious applications on Facebook. They discovered that 13% of one hundred and eleven thousand Facebook applications in their dataset were malicious applications. Recently, Fire et al. [16] proposed a method for detecting fake profiles in online social networks based on anomalies in a fake user's social structure. In this study, we present the the SPP software, which offers methods for improving Facebook user 3 privacy2. By using data collected by the SPP software and machine learning techniques, we present methods for constructing classifiers that can assist in identifying fake profiles. 2.2 Online Social Networks and Machine Learning With the increasing popularity of social networks many researchers had studied and used a combina- tion of data obtained from social networks and machine learning techniques to predict different user properties [25, 1, 37]. Furthermore, several studies used machine learning techniques to improve user security in online social networks [39, 23, 16]. In 2007, Liben-Nowell and Kleinberg [25] used machine learning techniques to predict links between users in different social networks (also referred to as the link prediction problem). In 2010, Stringhini et al. [39] proposed a method for detecting spammer profiles by using supervised learning algorithms. In the same year, Lee et al. [23] used machine learning and honeypots to uncover spammers in MySpace and Twitter. Sakaki et al. [37] used machine learning and content data analysis of Twitter users in order to detect events, such as earthquakes and typhoons, in real-time. In 2012, Altshuler et al. [1] used machine learning techniques to predict different user's properties, such as origin and ethnicity, inside the "Friends and Family" social network, which was created by logs extracted from a user's mobile device. Recently, Fire et al. [16] used the online social network's topological features to identify fake users in different online social networks. As part of this study we present a method for recommending to a Facebook user which of his friends might be a fake profile and should therefore, be restricted. Our method is based on the connection properties between a Facebook user and its friends and by using supervised learning techniques. This type of problem is to some degree similar to the problem of predicting link strength, studied by Kahanda and Nevill [21], and the problem of predicting positive and negative links (signed links), as Leskovec et al. [24] studied. Similarly to the study held by Kahanda and Nevill, in this study we extract a different set of meta-content features, such as the number of pictures and videos both the user and his friends were tagged in. In this study, we also predict the type of a negative relationship between users, similar to the study of Leskovec et al. However, in our study we aim to uncover fake profiles rather than identify the link sign or strength between two users. In addition, our study contrasts other studies, which used a major part of the social network topology to construct classifiers [21, 24, 16], because we construct our classifiers by using only variations of the data collected in real-time from the user's point of view rather than data collected from the social network administrator's point of view. By using user data, which was obtained in real-time only, we were able to quickly analyze each user's friends list with fewer resources and without invading the user's friend's privacy. 3 Social Privacy Protector Architecture To better protect the privacy of Facebook users we developed the Social Privacy Protector software. The SPP software consists of three main parts (see Figure 1), which work in synergy: a) Friends Analyzer Facebook application - which is responsible for identifying a user's friends who may pose a threat to the users privacy, b) SPP Firefox Add-on - which analyzes the user's privacy settings and assists the user in improving privacy settings with just one click, and c) HTTP Server - which is responsible for analyzing, storing, and caching software results for each user. In the remainder of this section, we describe in detail each individual part of the SPP software. 3.1 The Friends Analyzer Facebook Application The Friends Analyzer Facebook application (also referred to as SPP application) is the part of the SPP responsible for analyzing a user friends list to determine which of the user's friends may pose a threat to the user's privacy. After the user installs the Friends Analyzer application, the application scans the user's friends list and returns a credibility score for each one of the user's friends. Each friend's score is created by using simple heuristics or with a more sophisticated machine learning algorithm, 2An initial version of the SPP software was described, as work in progress, in our previous paper [15] 4 Figure 1: Social Privacy Protector Architecture. which takes into account the strength of the connection between the user and his friends. The strength of each connection is based on different connection features, such as the number of common friends between the user and his friend and the number of pictures and videos the user and his friend were tagged in together (see Section 4). At the end of the process, the user receives a web page, which includes a sorted list of all his friends according to each friend's score, where the friends with the lowest scores have the highest likelihood of being fake profiles appear on the top of the list (see Figure 2). For each friend in the returned sorted list, the user has the ability to restrict the friend's access to the user's private information by simply clicking on the restrict button attached to each friend in the sorted list. Moreover, the application provides the user an interface to view all his friends alphabetically and easily restricts access with a single click. This option enables Facebook users to protect their privacy not only from fake profiles but also from real profiles, such as exes, for whom they do not want to have access to their personal data stored in their Facebook profile. 3.2 Social Privacy Protector Firefox Add-on The Social Privacy Protector Firefox Add-on (also referred to as Add-on) is the part of the SPP software responsible for improving user privacy settings with just a few simple clicks. After the Add- on is installed on the user's Firefox browser, it begins to monitor the user's internet activity. When the Add-on identifies that the user logged onto his Facebook account, the Add-on then analyzes the number of applications installed on the user's Facebook profile and presents a warning with the number of installed applications, which may pose a threat to the user's privacy (see Figure 3). The Add-on also presents the top two results obtained by the Friends Analyzer Facebook application and suggests which friends to restrict (see Figure 3). The Add-on also detects when the user has entered Facebook's privacy settings page and presents the user with three new privacy setting options. The new privacy settings are based on the user's profile type and can be modified with one click (see Figure 4), instead of the more complex Facebook 5 Figure 2: Friends Analyzer Facebook application - user rank and sorted friends list. custom privacy settings that may contain up to 170 options [2]. Using the new Add-on privacy settings a user can simply chose the profile type most suitable for him out of three options: a) Celebrity setting - in this setting all of the user's information is public, b) Recommended setting - in this setting the user's privacy is only public to friends, however some of the user's details, such as profile name and pictures, are public, and c) Kids settings - in this setting the profile is only open to the user's friends and only friends of friends can apply for friend requests. Using this Add-on a user can easily control and improve their privacy without contacting a security expert. Moreover, parents can simply install this Add-on on their children's Facebook accounts in order to better protect their children's privacy on Facebook without needing to understand Facebook's different privacy setting options. Our Add-on is also easy for customizing privacy settings by adding more privacy option settings to different types of users. Furthermore, it is easy to customize our privacy settings by adding more optional privacy settings for different types of users. In this study, we utilized users data collected by the Add-on to further study the privacy settings of Facebook users. 3.3 HTTP Server The HTTP server is the part of the SPP responsible for connecting the SPP Firefox Add-on to the SPP Facebook application. When a user installs the SPP software, the server analyzes the user's friends list and identifies which of the user's friends may pose a threat on his security. Also, to enhance the application's performance, the HTTP server caches parts of the analyzed results. In order to protect the user's privacy, the application stores only the minimal number of features in an encrypted manner using RC4 encryption. 4 Methods and Experiments In this study our experiments are divided into two main parts. In the first part, we deployed an initial version of the SPP software in order to improve user privacy on Facebook. We also used the initial version to collect data on each SPP's user and his links. The main focus of this part is calculating the heuristic, which sorts the friends list and recommends which friends to restrict. Additionally, in 6 Figure 3: Social Privacy Protector Firefox Add-on - warning about installed applications and friends you may want to restrict. this part, we also present methods for analyzing the user privacy setting data collected by the Add-on to better understand Facebook user privacy settings and understand how much they are exposed to different security threats, such as information exposure to fake friends. In the second part, we use the data collected in the first part to learn more about Facebook user's privacy settings. Furthermore, we used the collected data in order to develop machine learning classifiers, which can identify Facebook profiles with higher likelihoods of being fake. Moreover, these classifiers can be used to replace the initial SPP heuristic with a more generic model, which can provide SPP users recommendations on which friends to restrict. In the second part our main focus is on constructing the machine learning classifiers and evaluating their performances. In the remainder of this section, we present in detail the methods used in each one of the two parts. 4.1 Deploying Social Privacy Protector - Initial Version After we developed the SPP's software according to the architecture described in Section 3, we had to develop a heuristic, which can quickly sort the friends list of each SPP user. In the initial version, we developed the heuristic to be as simple as possible and based it upon the hypothesis that most fake users do not have strong connections with real users. To estimate the strength of a connection between two users, we extracted lists of features and calculated a simple arithmetic heuristic. The heuristic's main constrain was that for every SPP user, it needed to analyze and evaluate hundreds or even thousands of connection strengths between the user and each one of his friends in a short period of time. Moreover, the heuristic needed to take into consideration the performance of the Facebook application API [10], in its calculation time of each feature. After testing and evaluating several different features, we decided to extract the following features for each SPP user (referred as u), and each one of his friends (referred as v): 1. Are-Family(u,v) - mark if u and v are defined in Facebook as being in the same family. The Are-Family feature prevents the cases in which the SPP application will mark a family member as a fake profile. 7 Figure 4: Social Privacy Protector Firefox Add-on - optimizing the user's privacy setting with one simple click. 2. Common-Chat-Messages(u,v) - the number of chat messages sent between u and v. We assume that in most cases, such as in a fake profile used to send spam messages, there will be no chat interaction between the user and the fake profile. However, when there are different types of fake profiles, such as fake profiles used by cyber predators, this feature will be less helpful in identifying the threat. 3. Common-Friends(u,v) - the number of mutual friends both u and v poses. The relevance of the Common-friends feature is very intuitive. It is expected that the larger the size of the common neighborhood, the higher the chances are that the friendship between the users is real. The Common-Friends feature was previously used to solve different versions of the link prediction problem [25, 21, 24, 17] and was found to be a very useful feature in many of these scenarios. 4. Common-Groups-Number(u,v) - the number of Facebook groups both u and v are members in. It is expected that the higher the number of groups both users are member of, the higher the chances that u and v have similar fields of interest, which might indicate that the friendship between u and v is real. The Common-Groups-Number feature was used in the study of Kahanda and Neville [21] to predict link strength. 5. Common-Posts-Number(u,v) - the number of posts both u and v posted on each other's wall in the last year. Similar post features were studied by Kahanda and Neville and were discovered to be very useful in predicting strong relationships between two Facebook users [21]. 6. Tagged-Photos-Number(u,v) - the number of photos both u and v were tagged in together. We assume that most fake profiles have almost no shared tagged photos with the user. The Tagged-Photos-Number feature was also used in the Kahanda and Neville study [21]. 7. Tagged-Videos-Number(u,v) - the number of video clips both u and v appeared in together. As in the case of tagged photos, we assume that most fake profiles have almost no shared tagged video clips with the user. 8 8. Friends-Number(u) and Friends-Number(v) - the total number of friends u and v have. These features are usually referred to as the degree of u and the degree of v, and were extracted from each user to assist us in improving the supervised learning classifiers, as described in Section 4.2. However, we did not use this feature when calculating the connection strength heuristics in SPP's initial version. In an attempt to build better fake profile prediction heuristics, we also tested the following features: a) the number of mutual Facebook likes both u and v gave to each other, and b) the number of comments both u and v posted on each other's wall posts. However, although these two features seemed promising in assisting us in identifying fake profiles, we did not use them in the end due to performance issues, i.e., calculating these two features was too time consuming and inappropriate to use in order to receive real-time results. After several tests and simple evaluations, we decided to use the following simple heuristic in order to define the Connection-Strength function between a user u and its friend v: Connection-Strength(u, v) = CS(u, v) := Common-F riends(u, v) + Common-Chat-M essages(u, v) + 2 · Common-Groups-N umber(u, v) + 2 · Common-P osts-N umber(u, v) + 2 · T agged-P hotos-N umber(u, v) + 2 · T agged-V ideos-N umber(u, v) + 1000 · Are-F amily(u, v) In order to tell SPP users which friends ought to be restricted, we ranked each user's friends list according to the Connection-Strength(u,v) function. Due to Facebook's estimations that 8.7% of all Facebook users do not belong to real profiles [12], we presented to each SPP user the top 10% of his friends who received the lowest Connection-Strength score (see illustration in Figure 2). To evaluate the performance of the Connection-Strength heuristic, we calculated three statistics on the heuristic's performances in restricting friends. First, we calculated the heuristic's restricting precision for different Connection-Strength values. This calculation was performed by measuring, for different Connection-Strength values, the ratio between the number of friends who were restricted and the total number of friends who received the exact Connection-Strength value. Second, we calculated the restriction rates according to the friends' ranking positions in the restriction interface. This cal- culation was performed by measuring the percentage of friends, which were restricted in each position in the restriction interface. Lastly, we also calculated the heuristic's average users precision at k for different k values, in the following manner. First, for each SPP user u, which had at least k friends, we calculated the user's Connection-Strength average precision at k. This was done by selecting k friends, which received the lowest Connection-Strength values with u out of all u's friends3. We then calculated the ratio between the number of friends u had restricted among the selected friends and k. After we finished calculating the Connection-Strength average precision at k for each user u, we then continued to calculate heuristic's average users precision at k, by simply summing up all the users' Connection-Strength average precision at k, and dividing the sum by the number of users with at least k friends. A formal arithmetical definition of the heuristic's average users precision at k is as follows: CS-Avg-P recision(k) := Σ{u∈U sersf riends(u)≥k}Pu(k) {u ∈ U sersf riends(u) ≥ k} Where U sers is a set, which contains all SPP users, f riends(u) is a set which contains all of u's Facebook friends, and Pu(k) defined to be the heuristic's precision at k for a user u: Pu(k) := Σ{f∈f riends(u)∃fi,...,fn−k∈f riends(u),∀j∈[i,..,n−k]CS(f )≥CS(fj )}is-restricted(u, f ) k . 3In case more than k friends received the lowest Connection-Strength values, we randomly removed friends with the highest Connection-Strength values, until we were left with exactly k friends. 9 Where is-restricted(u, f ) is a function, which returns 1 if a user u had restricted his friend f or 0 otherwise. The goal of the presented Connection-Strength heuristic was not to identify fake profiles in an optimal way, rather to make Facebook users more aware of the existence of fake profiles and the fact that these types of profiles can threaten their privacy. Additionally, we wanted to collect a unique dataset that would contain labeled profiles with high likelihoods of being fake profiles. In addition to collecting meta-content features through the SPP application, the SPP Firefox Add-on also collected the following users defined privacy settings each time the user used the Add-on: 1. Installed-Application-Number - the number of installed Facebook applications on the user's Facebook account. 2. Default-Privacy-Settings - the default user's privacy settings on Facebook, which can be one of these values: public, friends or custom. This setting is responsible for the scope in which content created by the user will be exposed by default. For example, if the default privacy settings are set to "friends" by default, only the user's friends can see his posted content. The SPP's Add-on only stored this value if the user's privacy was set to public or friends. This privacy setting default value for new Facebook users is set to public. 3. Lookup - regulates who can look up the user's Facebook profile by name. This setting can take one of the following values: everyone, friends or friends of friends. This privacy setting default value for new Facebook users is set to everyone. 4. Share-Address - this value is responsible for defining who can see the user's address. This setting can take one of the following values: everyone, friends or friends of friends. This privacy setting default value for new Facebook users is set to everyone. 5. Send-Messages - this value is responsible for defining who can send messages to the user. This setting can take one of the following values: everyone, friends or friends of friends. This privacy setting default value for new Facebook users is set to everyone. 6. Receive-Friend-Requests - this value is responsible for defining who can send friend request to the user. This setting is limited to two values only : everyone and friends of friends. The default value for this setting is everyone. 7. Tag-Suggestions - this value is responsible for defining which Facebook users will receive photo tag suggestions when photos that look like the user have been uploaded onto Facebook. This setting can take one of the following values: no one or friends. This privacy setting default value for new Facebook users is set to friends. 8. View-Birthday - this value is responsible for defining who can view the user's birthday. This setting can take one of the following values: everyone, friends or friends of friends. This privacy setting default value for new Facebook users is set to friends-of-friends. By analyzing and monitoring the privacy settings, we can learn more about the SPP user's privacy settings on Facebook. In addition, we can estimate how vulnerable Facebook users' information is to fake profile attacks. Furthermore, by analyzing the collected privacy settings, we can also identify other potential privacy risks, which are common to many different users. 4.2 Supervised Learning After, we deployed the SPP software and gathered enough data on which friends SPP users had restricted, and which friends they had not restricted, our next step was to use supervised learning techniques to construct fake profile identification classifiers. To construct the fake profile identification classifiers, we first needed to define the different datasets and their underlining features. Next, we used different supervised learning techniques to construct the classifiers. Lastly, we evaluated the classifiers using different evaluation methods and metrics. 10 In the remainder of this section we describe, in detail, the process of constructing and evaluating our classifiers. First, in Section 4.2.1, we describe how we defined the different datasets and their features. Second, in Section 4.2.2, we describe which methods were used to construct our classifiers and evaluate their performance. 4.2.1 Datasets and features The SPP application's initial version collected and calculated many different details about each con- nection between a SPP user and each one of his friends in real-time (see Section 4.1). Moreover, the SPP application presented the user with two interfaces for restricting his friends. The first restriction interface (referred to as the recommendation interface) presents the user with a list with the 10% of his friends who received the lowest Connection-Strength score. The second restriction interface (referred to as the alphabetical interface) presents the user with all of his friends in alphabetical order. Using these two restriction interfaces, we defined four types of links sets, two unrestricted links sets, and two restricted links sets: 1. All unrestricted links set - this set consists of all the links between the application users and their Facebook friends who were not restricted by the application. 2. Recommended unrestricted links set - this set consists of all the links between the applica- tion users and their Facebook friends who were recommended for restriction by the application due to a low Connection-Strength score, but who were not restricted by the user. 3. Recommended restricted links set - this set consists of all the links between the application users and their Facebook friends who were recommended for restriction by the application due to a low Connection-Strength score and who were restricted by the user. 4. Alphabetically restricted links set - this set consists of all the links between the application users and their Facebook friends who were not recommended for restriction by the application. However, the user deliberately chose to restrict them by using the alphabetical interface4. Using the defined above links sets, we define the following three datasets: 1. Fake profiles dataset - this dataset contains all the links in the Recommended unrestricted links set and in the All unrestricted links set. Namely, this dataset contains all friends who were restricted due to a relatively low Connection-Strength and all friends who were not restricted. Therefore, we believe that this dataset is suitable for constructing classifiers, which can predict friends, who mostly represent fake profiles, the user need to restrict. We believe that this dataset is suitable for replacing the Connection-Strength heuristics with a generic classifier, which can recommend to a SPP user, which friends to restrict. In addition, the classifiers constructed from this type of dataset can assist online network administrators in identifying fake profiles across the entire the network. 2. Friends restriction dataset - this dataset contains all the links in the alphabetically restricted links set, and in the All unrestricted links set. Namely, this dataset contains all the friends who were not restricted and all the friends who were restricted deliberately by the user, although they were not recommended by the SPP application. Therefore, we believe that this dataset is suitable for constructing classifiers, which can predict friends, who mostly represent real profiles the user prefers to restrict. 3. All links dataset - this dataset contains all the links in all four disjoint links sets. According to the dataset definition, this dataset is the largest among all defined datasets, we believe that like the Fake profiles dataset this dataset can be suitable for replacing the Connection-Strength heuristics with a generic classifier, which can recommend to a SPP user which friends to restrict. 4If a restricted user's friend was presented in the recommendation interface and was restricted by using the alpha- betical interface, the link between the user and the restricted friend was assigned to the recommended restricted links set. 11 For each link in the above defined links datasets, the SPP application calculated all of the 8 first link features defined in Section 4.1 in real-time including the Friends-Number(v)5 (referred to as the Friend Friends-Number). In addition, if it was arithmetically possible, we also calculated the following set of seven features: 1. Chat-Messages-Ratio(u,v) - the ratio between the number of chat message u and v sent to each other and the the total number of chat messages u sent to all of his friends. The formal Chat-Messages-Ratio definition is: Chat-M essages-Ratio(u, v) := Common-Chat-M essages(u, v) f∈f riends(u) Common-Chat-M essages(u, f ) Where f riends(u) is defined to be a set which contains all the friends of u. 2. Common-Groups-ratio(u,v) - the ratio between the number of Facebook groups both u and v have in common and the maximum number of groups which u and all of his friends have in common. The formal Common-Groups-Ratio is: Common-Groups - Ratio(u, v) := Common-Groups-N umber(u, v) max({Common-Groups-N umber(u, f )f ∈ f riends(u)}) 3. Common-Posts-Ratio(u,v) - the ratio between the number of posts both u and v posted on each others walls and the total number of posts which u posted on all his friends' walls. The formal Common-Posts-Ratio is: Common-P osts-Ratio(u, v) := Common-P osts-N umber(u, v) f∈f riends(u) Common-P osts-N umber(u, f ) (cid:80) (cid:80) (cid:80) (cid:80) 4. Common-Photos-Ratio(u,v) - the ratio between the number of tagged photos both u and v were tagged in together and the total number of photos, which u were tagged in. The formal Common-Photos-Ratio is: Common-P hotos-Ratio(u, v) := Common-P hotos-N umber(u, v) f∈f riends(u) Common-P hotos-N umber(u, f ) 5. Common-Video-Ratio(u,v) - the ratio between the number of videos both u and v were tagged in together on and the total number of videos, which u were tagged in. The formal Common-Video-Ratio is: Common-V ideo-Ratio(u, v) := Common-V ideo-N umber(u, v) f∈f riends(u) Common-V ideo-N umber(u, f ) 6. Is-Friend-Profile-Private(v) - in some cases the SPP application did not succeed in collecting v's friends number (Friends-Number(v)), and succeeded in collecting the Common-Friends(u,v) value, which returned a value greater than zero. This case may indicate that v's profile is set to be a private profile. With these cases in mind, we defined the Is-Friend-Profile-Private function to be a binary function, which returns true values in case the application did not succeed in collecting v's friends number and succeeded in collecting the Common-Friends(u,v) with a value greater than zero, or a false value otherwise. 7. Jaccard's-Coefficient(u,v) - Jaccard's-coefficient is a well-known feature for link prediction [25, 21, 17]. The Jaccard's coefficient is defined as the number of common-friends u and v have divided by the sum of distinct friends both u and v have together. The formal Jaccard's- Coefficient definition is: Jaccard(cid:48)s - Coef f icient(u, v) := F riends-N umber(u) + F riends-N umber(v) − Common-F riends(u, v) A higher value of Jaccard's-coefficient denotes a stronger link between two Facebook users. Common-F riends(u, v) 5In some cases we were not able to extract the user's (v) friends number probably due to the v's privacy settings. 12 4.2.2 Classifiers Construction and Evaluation Using the three datasets and the 15 features defined in the previous sections, we constructed classifiers for fake profile identification and for recommending profiles for restriction. The process of constructing and evaluating the different classifiers was as follows. First we matched the suitable datasets for each type of classification mission in the following manner: a) for identifying fake profiles we used Fake profiles dataset, b) for recommending real profiles for restriction we used the Friends restriction dataset, and c) for replacing recommending to SPP users which real and fake friends to restrict we used the All links dataset. Next, for each link in each one of the datasets, we extracted the 15 features defined in Sections 4.1 and 4.2.1, and created a vector set for each link. Furthermore, we added an additional binary target feature that indicates if the link between the SPP user and his friend was restricted by the SPP user to each link's features vector set. Due to the fact that the majority of the links in each dataset had not been restricted, these datasets were overwhelmingly imbalanced with restricted links as a minority class. Therefore, a naive algorithm that always predicts "not restricted", will present good prediction precision. To overcome the datasets imbalance problem we used a similar undersampling methodology used by Guha et al. to predict trust [19] and by Leskovec et al. [24] to predict positive and negative links. According, to this methodology we transform each imbalanced dataset into a balanced dataset by combing all the restricted links in each dataset and adding to them an equal number of randomly selected unrestricted links from each dataset. Afterwards, we used the balanced datasets with the updated extracted links' features vector sets to construct several classifiers by using WEKA [20], a popular suite of machine learning software written in Java and developed at the University of Waikato, New Zealand. We used WEKA's C4.5 (J48), IBk, NaiveBayes, Bagging, AdaBoostM1, RotationForest, and RandomForest implementations of the corresponding algorithms. In addition, we used the simple OneR classifier as a baseline for the performance of the other classifiers. For each of these algorithms, most of the configurable parameters were set to their default values with the following exceptions: for C4.5, the minimum number of instances per leaf parameter was between the values of 2, 6, 8 and 10; for IBk, its k parameter was set to 5 and 10; The ensemble methods were configured as follows: The number of iterations for all ensemble methods was set to 100. The Bagging, AdaBoostM1, and RotationForest algorithms were evaluated using J48 as the base classifier with the number of instances per leaf set to 4, 6, 8, and 10. Next, we evaluated our classifiers using the common 10-folds cross validation approach. We used the area-under-curve (AUC), f-measure, true-positive and false-positive rate to evaluate the different classifiers' performances. Additionally, in order to obtain an indication of the usefulness of the various features, we also analyzed the features importance by using WEKA's information gain attribute selection algorithm. Furthermore, in order to evaluate the classifiers recommendations precision at top k (precision@k), we selected the machine learning algorithm, which presented the highest AUC in the above evaluations and used two evaluation methods to measure the performance of the algorithm on the different datasets. In the first evaluation method, we split our datasets into training sets and testing sets. For each one of the three balanced datasets, we randomly split each dataset into a training dataset, which contained 2 3 3 of the labeled instances. Afterwards, of the labeled instances and a testing dataset, which contained 1 we constructed classifiers using the training dataset only. Next, we used the classifiers to classify the profiles in the testing dataset and sorted the instances according to the classifiers' prediction probabilities in descending order, where the links, which received the highest probability of being restricted were first. We then evaluated the classifiers' predictions precisions for the top k predictions, for different values of k. In the second evaluation method, our goal was to measure the classifiers recommendations average users precision at k. To achieve this goal we used the following method. First, we selected a user out of all SPP users. Afterwards, we created a training dataset using all SPP users' links without the selected user's links. Next, we balanced the training dataset using the same undersampling method described above. Afterwards, we constructed a classifier using the training dataset and used the selected user's links as a testing dataset. We used the constructed classifier to predict the probability of restriction for each link in the selected user's links. We then sorted the classifier's predictions in descending order where the links, which received the highest probability of being restricted were first. Subsequently, we measured the classifier's predictions precision for different k values. Lastly, we repeated this process 13 for each one of all SPP users and calculated the average classifiers' precisions for different k values. Using these evaluation methods, we were able evaluate how precise our classifiers are in recom- mending which friends to restrict both from the SPP users' point of view, and from the online social network administrator point of view. 5 Results The initial version of the SPP software was formally launched at the end of June 2012 as free to use software [14, 15]. The software launch received massive media coverage with hundreds of online articles and interviews in leading blogs and news websites, such as Fox news [3] and NBC news [32]. Due to the media coverage, from the 27th of June, 2012 to the 10th of November, 2012, 3,017 users from more than twenty countries installed the SPP application out of which 527 users used the SPP application to restrict 9,005 friends, with at least one friend restricted for each user. In addition, more than 1,676 users had installed the SPP Firefox Add-on and removed at least 1,792 applications. In the remainder of this section we present the results obtained from analyzing the collected SPP software data in the following manner. First, in Section 5.1, we present the datasets obtained by the SPP application. Afterwards, in Section 5.2, we present the results obtained by our machine learning classifiers. Lastly, in Section 5.3 we present statistics on the success of our Add-on to assist Facebook users in removing unneeded applications from their profiles. Furthermore, in this section, we also presented different statistics about Facebook user privacy settings obtained from the SPP Add-on. 5.1 Collected Datasets After the initial software launch the SPP application was installed by 3,017 users out of which 527 users had restricted 9,005 friends. All friends were restricted between the 27th of June, 2012 and the 10th of November, 2012. To our great surprise 355 SPP application users used the application not only to remove users that received low Connection-Strength score, but to also search and restrict specific friends that are probably real profiles by name. Using the collected users' data we created three datasets as described in Section 4.2.1 (see Table 1). The first dataset was the Fake-profiles dataset, this dataset contained 141,146 out of which the 434 SPP users had restricted 2,860 links (2.03% of all links), which were recommended by the SPP application. The second dataset was the Friends-restriction dataset, this dataset contained 144,431 links out of which the 355 users had restricted 6,145 links (4.25% of all links), that were specifically chosen for restriction by the users using the Alphabetical-interface. The last dataset was the All links dataset, which contained 151,825 links out of which 9,005 (6.01% of all links), were restricted. As expected all three datasets were overwhelmingly imbalanced with imbalance rates ranging from 2.03% to 6.01%. Table 1: Links Datasets Users Number Restricted Link Unrestricted Links Total Links Fake-Profiles Friends Restriction All Links 434 355 527 2,860 (2.03%) 6,145 (4.25%) 9,005 (6.01%) 138,286 138,286 138,286 141,146 144,431 147,291 To better understand the differences between the restricted links features and unrestricted links features, we calculated the average values of each extracted feature in each dataset for each link type (see Table 2). It can be noted that in all the examined features, except for the Friend Friends-Number and Is-Friend-Profile-Private features, the restricted links features received a lower average than the unrestricted links features in each dataset. To understand how well the Connection-Strength heuristic performed, we calculated, as described in Section 4.1, the heuristic's restricting precision for different Connection-Strength values (see Fig- ure 5), the heuristic restriction rates according to the friends' ranking positions in the Restriction interface (See Figure 6), and the heuristic's average users precision at k for different values of k (see Figure 7). 14 Table 2: Features Average Values for Different Datasets Friends Link Type Fake Feature Profiles Restriction Are-Family Common-Chat-Messages Common-Friends Common-Groups-Number Common-Posts-Number Tagged-Photos-Number Tagged-Videos-Number Friend Friends-Number Chat-Message-Ratio Common-Groups-Ratio Common-Posts-Ratio Common-Photos-Ratio Common-Video-Ratio Is-Friend-Profile-Private Jaccard's-Coefficient Restricted Unrestricted Restricted Unrestricted Restricted Unrestricted Restricted Unrestricted Restricted Unrestricted Restricted Unrestricted Restricted Unrestricted Restricted Unrestricted Restricted Unrestricted Restricted Unrestricted Restricted Unrestricted Restricted Unrestricted Restricted Unrestricted Restricted Unrestricted Restricted Unrestricted 0 9 links 0.02 30.86 1.44 36.78 0.028 0.689 0.008 0.147 0.004 0.3 0 0.017 627.31 703.31 2.46 · 10−5 0.004 0.006 0.118 0.0003 0.0035 2.23 · 10−5 0.0034 0 0.0027 5.87% 9.81% 0.003 0.045 1 link 9 links 6.35 30.86 19.8 36.78 0.56 0.689 0.069 0.147 0.208 0.3 0.007 0.017 819.57 703.31 0.003 0.004 0.108 0.118 0.003 0.0035 0.003 0.0034 0.001 0.0027 10.79% 9.81% 0.034 0.045 All Links 1 link 9 links 4.34 30.86 13.97 36.78 0.392 0.689 0.049 0.147 0.143 0.3 0.005 0.017 756.25 703.31 0.002 0.004 0.076 0.118 0.002 0.0035 0.002 0.0034 0.0007 0.0027 9.23% 9.81% 0.024 0.045 Although the Connection-Strength heuristic was quite simple, it presented an average users preci- sion of 33.6% at 1, an average users precision of 27.1% at 10, and an average users precision of 11% at 100 (see Figure 7). In addition, 31.7% of the friends, which appeared in the second position in the Restriction interface, due to a low Connection-Strength score, were actually restricted by the SPP users (See Figure 6). Furthermore, 28% of the SPP users' friends who received a Connection-Strength of 0 were also restricted (see Figure 5). However, the friends' restriction rates sharply declined when the Connection-Strength score increased. For example, only 10%, of the users' friends, which received a Connection-Strength equal to 3 were actually restricted. 5.2 Classifiers' Results From the three imbalanced datasets, we created three balanced datasets by using all the restricted links in each dataset and randomly choosing an equal amount of unrestricted links. We then used the balanced dataset and evaluated the specified machine learning algorithms (see Section 4.2.2) using a 10-fold cross-validation approach. The evaluation results of the different classifiers are presented in Figure 8 and in Table 3. It can be seen that on all datasets the Rotation-Forest classification algorithm presented the best AUC results among all the ensemble classifiers and the J48 decision tree classification algorithm presented the best results among all the non-ensemble classifiers. In addition, 15 Figure 5: Friends restriction precision for different Connection-Strength values - it can be noted that among all users' friends, which received a Connection-Strength of 3, only 10% were actually restricted. Figure 6: Connection-Strength restriction rates according to friends' ranking positions in the Restric- tion interface - it can be noted that among all friends, which were ranked in the first position in the friends Restriction interface 31.1% were actually restricted by the SPP users. it can be noted that on all datasets the Rotation-Forest classifier presented considerably better results than the simple OneR classifier, which we used as baseline. 3 of the links and a testing dataset, which contained 1 After, we discovered that the Rotation-Forest classifier presented the best overall results, we evalu- ated the Rotation-Forest classifier precision at k for different values of k on the different datasets. We first calculated the classifier precision for different k values by splitting each dataset into a training 3 of the links. The dataset, which contained 2 results of this precision at k evaluation are presented in Figure 9. It can be noted that the Rotation- Forest classifiers presented precision at 200 of 98%, 93%, and 90% for the Friends restriction dataset, Fake profiles datasets, and All links dataset respectively. In addition, it can been noted that the classifiers' precision at 500 was 94%, 91%, and 88% for the Fake profiles datasets, Friends restriction dataset, and All links dataset. Hence, out of 500 links, which ranked were by the the Rotation-Forest classifiers as links with the highest likelihood of being restrict by the SPP application users, 470, 455, and 440 links were actually restricted in the Fake profiles datasets, Friends restriction dataset, and All links dataset respectively. In order to estimate the classifiers' recommendations precision according to the SPP users' point 16 0.28 0.17 0.12 0.10 0.05 0.05 0.05 0.04 0.03 0.03 0.02 0.02 0.03 0.03 00.050.10.150.20.250.30102030405060708090100Precision Connection-Strength 0.31 0.22 0.16 0.13 0.10 0.07 0.07 0.08 0.06 0.06 0.07 00.050.10.150.20.250.30.350102030405060708090100Restriction Rate Rank Position Figure 7: Connection-Strength average users precision at k - it can be noted that the Heuristic's average users precision at 1 and average users precision at 100 was 33.6% and 11.1% respectively. Figure 8: Classifiers AUC on the Different Datasets - it can be noted that the Rotation-Forest classifier received the highest AUC rates on all three datasets. of view, we also calculated the Rotation-Forest classifier average users precision k, as described in Section 4.2.2, on the different datasets for different values of k 6. The results of this precision at k evaluation are presented in Figure 10. It can be noticed that the Rotation-Forest classifiers presented precision at 10 of 24%, 23%, and 14% for the All links dataset, Fake profiles datasets, and Friends restriction dataset respectively. The Rotation-Forest classifier's results on the All links dataset indicated that on average 2.4 of the users' friends, which received the top ten highest probabilities of being restricted among all the friends of each user were actually restricted. However, the Rotation-Forest classifier's results on the Restricted profiles dataset indicated that on average only 1.4 of the users' friends, which received the top ten highest probabilities of being restricted among all the friends of each user had actually been restricted. To obtain an indication of the usefulness of the various features, we also calculated the differ- ent features importance using WEKA's information gain attribute selection algorithm (see Table 4). According to the information gain selection algorithm the top two most useful features on all three datasets were the Common-Friends feature and the Jaccard's-Coefficient feature. Furthermore, ac- cording to the results there are differences between the features scores in the different datasets. For 6In case of the Friends profiles datasets, we calculated the average users precision for 355 SPP application users only, which for certain were familiar with alphabetical interface and used it to restrict their friends. 17 0.34 0.31 0.27 0.22 0.17 0.15 0.12 0.11 0.10 0.10 0.09 0.08 0.08 00.050.10.150.20.250.30.350.4020406080100120140160180200Acerage Users Precision k 0.861 0.925 0.833 0.902 0.946 0.937 0.948 0.933 0.511 0.684 0.587 0.645 0.73 0.698 0.79 0.706 0.608 0.72 0.545 0.663 0.75 0.728 0.778 0.716 00.10.20.30.40.50.60.70.80.91OneRJ48IBK (K=10)Naïve-BayesBaggingAdaBoostM1RotationForestRandomForestFake-ProfilesFriends RestrictionAll Links Table 3: Classifiers' Performance on the Different Datasets Classifier Measure Fake Profiles Friends Profiles All Links Restriction OneR J48 IBK (K=10) Naive-Bayes Bagging AdaBoostM1 Rotation-Forest Random-Forest AUC F-Measure False-Positive True-Positive AUC F-Measure False-Positive True-Positive AUC F-Measure False-Positive True-Positive AUC F-Measure False-Positive True-Positive AUC F-Measure False-Positive True-Positive AUC F-Measure False-Positive True-Positive AUC F-Measure False-Positive True-Positive AUC F-Measure False-Positive True-Positive 0.861 0.867 0.179 0.902 0.925 0.885 0.179 0.937 0.833 0.744 0.174 0.696 0.902 0.833 0.373 0.979 0.946 0.89 0.171 0.938 0.937 0.882 0.163 0.941 0.948 0.897 0.158 0.941 0.933 0.858 0.14 0.857 0.511 0.531 0.532 0.554 0.684 0.668 0.498 0.754 0.587 0.49 0.289 0.419 0.645 0.678 0.856 0.955 0.73 0.677 0.403 0.717 0.698 0.645 0.403 0.671 0.79 0.719 0.336 0.75 0.706 0.613 0.278 0.565 0.608 0.616 0.414 0.623 0.72 0.659 0.321 0.645 0.545 0.637 0.749 0.817 0.663 0.287 0.055 0.177 0.75 0.675 0.3 0.662 0.728 0.657 0.312 0.643 0.778 0.696 0.275 0.681 0.716 0.663 0.369 0.679 example, the Common-Groups-Ratio feature received a value of 0.113 in the Fake-profile dataset and a value of only 0.004 in the Friends-restriction dataset, and the Is-Friend-Profile-Private received a value of 0.056 in the Friends-restriction dataset and a value of only 0.0002 in the All links dataset. 5.3 Add-on Results The SPP Firefox Add-on was downloaded more than 1,6767 times between the 27th of June, 2012 and the 10th of November, 2012. During that time we succeeded in collecting data with the number of installed Facebook applications from 1,676 different Facebook users. This data was collected on 21,524 different occasions. Furthermore, we also succeeded in collecting SPP users' privacy settings of at least 67 Facebook users on 129 different occasions8. 7The SPP Add-on was available for download from several locations, such as the Firefox Add-ons website and the PrivacyProtector.net website. Due to the fact that not all locations store the number of downloads, we can only estimate the number of downloads according to our HTTP Server logs. 8Due to the fact that not all SPP users opened their Facebook privacy settings during this time period, and probably due to problems in parsing the different Facebook privacy settings page layouts, we succeeded in collecting the SPP users' privacy settings for only a limited number of users. 18 Figure 9: Rotation-Forest Precision@k - it can been seen that the classifiers' precision at 100 was 98%, 91%, and 91% for the Friends restriction dataset, Fake profiles datasets, and All links dataset respectively. Table 4: Information Gain Values of Different Features for Different Datasets By analyzing the collected applications data we discovered that the number of Facebook appli- cations installed on users' profiles, at the time they initially installed our Add-on, ranged from one installed application to 1,243 installed applications, with an average of 42.266 applications per user. Moreover, according to the installed applications distribution, we can observe that about 34.96% of the users have less than ten applications installed on their profiles. However, 30.31% of the users have at least 40 installed applications and 10.68% have more than 100 applications installed on their profiles (see Figure 11). In addition to calculating the statistics on the number of installed Facebook applications, we also tested if the SPP users had used the Add-on to remove part of their installed Facebook applications. In order to identify if a user has removed the Facebook applications using the Add-on, we check what the user's installed applications numbers up to a day after the Add-on is initially installed. Our Add-on succeeded to collect the data of 626 users a day after the Add-on is initially installed. Out of these 626 users 111 (17.73%), had removed 1,792 applications, while 149 (23.8%), users added 192 applications, and 366 (58.47%) users did not add or remove any applications (see Figure 12). A closer look at the application removal data reveals that on average each user from the 111 users removed 34.7% of all installed applications and 32 (28.8%), users had removed at least 50% of all their installed applications (see Figure 13) . If we look at the overall time period of our experiments, from the 27th of June, 2012 to the 10th of November, 2012, we can see that out of 1,676 users 335 (19.99%), users decreased the number of 19 0.93 0.94 0.94 0.94 0.93 0.92 0.90 0.89 0.87 0.98 0.98 0.96 0.95 0.91 0.89 0.85 0.84 0.82 0.80 0.80 0.92 0.90 0.88 0.90 0.88 0.88 0.88 0.88 0.87 0.85 0.80.820.840.860.880.90.920.940.960.98101002003004005006007008009001000Precision K Fake Profiles DatasetFriends Restriction DatasetAll Links Dataset Common-Friends Jaccard's-Coefficient Common-Groups-Number Common-Groups-Ratio Is Friend Profile Private Common-Posts-Ratio Friend Friends-Number Common-Chat-Messages Common-Posts-Ratio Common-Posts-Number Chat-Message-Ratio Tagged-Photos-Number Common-Photos-Ratio Tagged-Videos-Number Common-Video-Ratio Is Family Fake Profiles 0.521 0.466 0.122 0.113 0.03 0.029 0.047 0.045 0.029 0.034 0.045 0.035 0.029 0.005 0.001 0 Friends Restriction 0.036 0.012 0.004 0.003 0.056 0.016 0.003 0.003 0.016 0.008 0 0.003 0.005 0.001 0.001 0 All Links 0.102 0.079 0.015 0.017 0.0002 0.015 0.01 0.008 0.015 0.014 0.005 0.008 0.008 0.001 0.001 0 Average 0.22 0.186 0.047 0.044 0.029 0.02 0.02 0.019 0.02 0.019 0.017 0.015 0.014 0.002 0.001 0 Figure 10: Rotation-Forest average users' precision@k - it can been seen that the classifiers' average users precisions at 20 were 21%, 20%, and 14% for the All links dataset, Fake profiles datasets, and Friends restriction dataset respectively. Figure 11: Distribution of The Number of Installed Facebook Applications - it can be noted that 10.68% of the users have more than 100 applications installed on their profiles. installed applications on their profiles. These users had removed 5,537 applications with an average of 16.52 application removals per user and a median of seven. In addition to checking how many applications were removed, we also checked how many new applications were installed to each of the Add-on users. To achieve this goal, we first focused on the group of Add-on users, which to the best of our knowledge had more applications installed on their profile at the end of the 10th of November, 2012 than in the day they first installed the Add-on. For these user groups, we calculated how many applications were added to their profiles on an average each week. We discovered that out of 1,676 users, 389 (23.2%), users increased the number of installed applications on their profile ranging from 0.05 to 107.33 average of new application installations per day (with a median of 0.636 and an average of 1.91). We also analyzed the distribution of the privacy-settings collected from the 67 unique Add-on users (see Table 5). It can be noticed that 74.62% of the users set their default privacy settings to be exposed to everyone. Moreover, according to the users privacy settings it can be noticed that almost all the user information, except Tag-Suggestions, is exposed to the friends of the user. In addition, we also tested how many Add-on users changed their privacy settings during this time period, and discovered that according to our logs 14 (20.9%) Add-on users changed their privacy settings. However, after a 20 0.23 0.20 0.13 0.09 0.08 0.07 0.06 0.06 0.14 0.14 0.14 0.13 0.12 0.12 0.10 0.08 0.21 0.24 0.24 0.21 0.16 0.15 0.13 0.11 0.10 0.08 0.07 00.050.10.150.20.250.3020406080100120140Average Users Precision K Fake Profiles DatasetFriends Restriction DatasetAll Link Dataset 586 300 165 117 73 79 71 49 32 25 17 20 17 15 13 8 9 8 6 10 56 0100200300400500600Number of Users Number of Installed Apllications Figure 12: Distribution of the Difference in Installed Applications Number Day After the Add-on Installation. short while the majority of these fourteen users returned to their old, less restricted privacy settings. Table 5: Add-on Unique Users Privacy Settings Distribution Users Settings Public/ Everyone Friends Friends of Friends No one Default Lookup Privacy Settings 74.62% 74.62% Share Address Messages Send - 74.63% 23.88% 25.38% 100% 25.27% - - - - - - - - Receive Friend Req. Tag Sugg. View Birthday - - 86.76% - 11.94% 52.87% - - 88.06% - 23.88% 6 Discussion By analyzing the results presented in Section 5, we can notice the following: First, we notice that the initial SPP application results presented relatively good performances. Although we defined the Connection-Strength heuristic to be quite simple; it presented remarkable precision, where on average 31.1% of the users' friends, which were ranked in first place were actually restricted (see Figure 6). Furthermore, the heuristic also presented an average users precision of 33.6% at 1, an average users precision of 27% at 10, and an average users precision of 11% at 100 (see Figure 7). However, the Connection-Strength heuristic was not able to present a generic method, with high true-positive rates and low false-positive rates, for recommending the restriction of links. For example, only 10% of the SPP users' friends who received a Connection-Strength with a value of 3 were restricted (see Figure 5). Second, among all tested machine learning algorithms the Rotation-Forest classifiers performed best on all datasets, with especially good results for AUC of 0.948 and a false-positive rate of 15.8% on the Fake profiles dataset (see Table 3). Third, according to the results, the Rotation-Forest classifiers' average users precision at 1 on the All links dataset datasets and on the Fake-profiles it was 21% and 20%, respectively. These results were worse than the results presented by the Connection-Strength heuristic, which presented an av- erage users precision at 1 of 34%. However, the classifiers average users precision at k for higher k values was nearly the same as the Connection-Strength heuristic's precision at k. For example, 21 3 26 20 41 21 366 130 19 050100150200250300350400-183 to -100-99 to -20-10-19-9 to -2-1012 to 10Number of Users Difference in Number of Installed Applications Figure 13: Removed Application Percentage - every slice of the pie represent the percent of applications removed by a percent of users. For example, 9% of the Add-on users removed between 90%-100% of all applications installed on their profiles. It can be noted that about 29% of all the users have removed more than 50% of all applications installed on their profiles. Connection-Strength heuristic average users precision at 20 was 22%, while the Rotation-Forest clas- sifiers' average users precision at 20 was 21% on All links dataset and 20% on Fake-profiles datasets (see Figures 7 and 10). Nevertheless, using Rotation-Forest classifiers has many advantages, which the Connection-Strength heuristic does not have, such as presenting a generic model for links restriction recommendation, and presenting the restriction probability for each link in the network without the need to compare each link to other links of the same user as is done in the case of the Connection- Strength heuristic. Fourth, in contrast to the other classifiers, the classifier which was constructed from the Restricted friends dataset using the Rotation-Forest algorithm presented a relatively low average users precisions at 1 of 14% (see Figure 10). However, this precision is significantly better than the precision obtained by random guessing, which stands on 4.25%, in the Friends restriction dataset. We assume that this classifier presented a relatively low performance because the restricted friends in this dataset were mainly real friends, which the SPP users chose to restrict for different reasons. We assume that these reasons cannot be inferred from the features we extracted in the SPP's initial version. Five, when the Rotation-Forest classifiers were evaluated on the general scenario of predicting which links to restrict among all users' links, the classifiers presented very high precision rates. For example, the Rotation-Forest classifier, which was constructed from Fake profiles dataset links presented 91% precision at 100 and 94% precision at 500 (see Figure 9). Moreover, the Rotation-Forest classifier, which was constructed from the Friends restriction dataset presented impressive precision at 100 of 98%. These results indicate that the classifiers can be used not only by the social network users, but also by the online social network administrator in order to identify fake profiles among all profiles on the network. Six, according to the information gain results we can conclude that on all datasets the most useful features were the Common-friends feature and the Jaccard's-Coefficent feature (see Table 4). Additionally, the Is-Friend-Profile-Private was found to be very useful in the case of the Friends restriction dataset indicating that friends, which have their profile set to be private have a higher likelihood of being restricted. Moreover, according to these results it is noticeable that the Is Family, and the Tagged-Video-Number features were not so useful. Removing the extraction of these features in future versions can assist in improving the SPP application run time without significantly affecting 22 9% 8% 12% 18% 14% 15% 24% 90%-100%70%-90%50%-70%30%-50%20%-30%10%-20%0%-10%Application Removal Rate the results. Seven, according to the applications statistic results it can be noted that many Facebook users installed many applications on their Facebook accounts, which can jeopardize their privacy. According to our results out of 1,676 examined Facebook users, 30.31% of the users had at least forty installed applications and 10.68% of the users had more than a hundred installed applications (See Figure 11). Moreover, according to our results, out of the 111 users, which used the SPP Add-on for application removal, 28.2% removed more than 50% of all their installed applications a day after they installed the SPP Add-on (see Figure 13). These results indicate that in many cases the installed applications are unwanted or unneeded applications. Furthermore, our results also uncovered an alarming phenomenon; namely, many Facebook users install new applications weekly. According to our results 389 out of 1,676 users had increased the number of installed Facebook applications on their profiles with an average number of 1.91 new application installations per week. Eight, according to the collected users' privacy statistics we can see that almost all of the examined users information is available to friends, leaving the users' information exposed to fake friends (See Table 5). In addition, the vast majority of examined users also set their "Default Privacy Setting" to be accessed by everyone. This result indicates that many users do not protect their personal information and leave it exposed to the public's view. Lastly, according to the overall results we can see that SPP software has assisted its users in protecting their privacy both by restricting friends and by removing unwanted Facebook applications. However, the SPP software did not succeeded in assisting users to improve their privacy settings in most cases. 7 Conclusions In this study, we presented the SPP software, which aims to better protect user's privacy in Facebook. We presented in detail the general architecture of the SPP software (see Section 3). According to this architecture, the SPP software can be divided into three layers of protection. The first layer helps to restrict a user's friend's access to personal information. The second layer helps to identify and warn the user about installed Facebook applications, which can violate the user's privacy. The third layer helps the user to adjust their privacy settings with one click. According to this software architecture the heart of the SPP software lays in the function, which is responsible for recommending to each user, which friends to restrict. This function can be a simple heuristic or a more complicated machine learning classifier. In the initial version of the SPP software we chose to implement the Connection-Strength heuristic, which was responsible for recommending to each user, which of his friends to restrict (see Section 4.1). By using the software interfaces and the Connection-Strength heuristic recommendations, 527 out of 3,017 software users had restricted 9,005 friends in less than four months. According to the results of the Connection-Strength heuristic we can conclude that the Connection-Strength heuristic presented the users with a relatively remarkable recommendation. By using these recommendations the SPP users' had restricted 30.87% of their friends, which appeared in the first position in the application's Restriction interface (see Figure 6). However, the Connection-Strength did not provide a general method of identifying which of the users' links need to be restricted. To create general link restriction recommendation methods we chose to use a supervised learning approach. By using the unique data, which was created by the initial SPP version, we created three types of datasets for different friend restriction scenarios(see Section 4). We used these datasets to construct and to compare different machine learning algorithms to identify which algorithm can provide the best results (see Section 4.2.2). We discovered that the Rotation-Forest algorithm presented the best AUC and false-positive rates results on all three datasets (see Table 3). We then showed that the Rotation-Forest classifiers had been created from the Fake profiles dataset and the All links dataset presented good average users precision at k results (see Figure 10). Furthermore, we demonstrated that these classifiers can provide Facebook administrators with a method, which can assist them in identifying fake profiles among all users in the network (see Figure 9). However, according to our evaluations these classifiers suffer from relatively high false-positive rates. We believe that these false- 23 positive rates can be considerably reduced if the network administrator uses the classifiers to evaluate several links, instead of one link only, for each suspicious profile, which the classifiers had marked off as being a fake profile. We hope to verify this assumption in future research. In this study, we also collected statistics form 1,676 different Facebook users on the number of applications installed on their Facebook profiles during different time periods. According to these statistics we discovered that many Facebook users have an alarming number of applications installed on their profiles, where 30.31% of the users had at least forty installed applications (See Figure 11). In addition, our statistical analysis also showed that many users continued to install new applications with an average of 1.91 new applications every week. Fortunately, according to our results, we discovered that at least 111 SPP Add-on users had used the SPP Add-on to improve their privacy and removed at least 1,792 applications (see Figure 12). These results indicate that by making users more aware of the existence of installed applications we can assist in reducing the number of the installed applications, and may decrease the exposure of users' personal information to third party companies. Furthermore, in this study we also collected statistics on the privacy settings of 67 unique Facebook users. According to these privacy statistics we can conclude that a majority of the users expose their private information to friends, and in many cases even to the public. Once again, these statistics sharply demonstrate how exposed Facebook users information can be to both fake profile attacks and third party Facebook applications. In the future, we hope to continue our study and provide an updated version of the SPP Add-on, which will be able to support more web browsers, such as Chrome and Internet Explorer. In addition, we plan to remove the extraction of less useful features, like the Tagged-Video-Number feature, and through this improve the SPP application performance. We hope that these improvements will assist SPP users to restrict more fake profiles and through this increase the size of our classifiers' training set. We also believe that this study has several future research directions, which can improve the iden- tification of fake profiles in online social networks. A possible direction is to extract more complicated topological features, such as the number of communities of each user, and use them to construct better classifiers with lower false-positive rates. In our previous study [16], we demonstrated that these type of features can assist in identifying fake profiles. Another possible direction, which can be used to improve the classifiers performances is to construct the classifiers by using oversampling techniques, like SMOTE [5], to deal with the dataset imbalance issue instead of the under sampling techniques we used in this study. We also hope to test the constructed classifiers performance on different on- line social networks, such as Google+ and Twitter. Another future direction we want to examine is the usage of the SPP software as an educating tool. We also hope to examine if users utilizing the SPP software to restrict friends and remove applications became more aware of their privacy, and as result tended to accept less friend requests and installed fewer applications. In future studies, we also hope to perform a deeper analysis on the unique datasets we obtained with the SPP software and extract different insights on connections between Facebook users. We also hope to test the developed algorithms to improve users' security and privacy in other online social networks. 8 Availability The Social Privacy Protector and parts of its source code are available for download from http: //www.socialprotector.net. The Friend Analyzer Facebook application is available to download from https://apps.facebook.com/friend_analyzer_app. A video with detailed explanations on how to use the SPP application is available in http://www.youtube.com/watch?v=Uf0LQsP4sSs References [1] Y. Altshuler, M. Fire, N. Aharony, Y. Elovici, and A. Pentland. How many makes a crowd? on the evolution of learning as a factor of community coverage. Social Computing, Behavioral-Cultural Modeling and Prediction, pages 43 -- 52, 2012. 24 [2] M. Anwar and P. Fong. A visualization tool for evaluating access control policies in facebook-style social network systems. 2012. [3] A. Bigos. New facebook app helps http://www.foxcharlotte.com/news/top-stories/New-Facebook-App-Helps-Protects-Kids- Against-Online-Criminals-162540726.html, 2012. [Online; accessed 21-September-2012]. protect kids against online criminals. [4] Y. Boshmaf, I. Muslukhov, K. Beznosov, and M. Ripeanu. The socialbot network: when bots socialize for fame and money. In Proceedings of the 27th Annual Computer Security Applications Conference, pages 93 -- 102. ACM, 2011. [5] N. Chawla, K. Bowyer, L. Hall, and W. Kegelmeyer. Smote: synthetic minority over-sampling technique. arXiv preprint arXiv:1106.1813, 2011. [6] D. DeBarr and H. Wechsler. Using social network analysis for spam detection. Advances in Social Computing, pages 62 -- 69, 2010. [7] W. Defensio. http://www.defensio.com/. [Online; accessed 1-September-2012]. [8] M. Egele, A. Moser, C. Kruegel, and E. Kirda. Pox: Protecting users from malicious facebook applications. In Pervasive Computing and Communications Workshops (PERCOM Workshops), 2011 IEEE International Conference on, pages 288 -- 294. IEEE, 2011. [9] Facebook. http://www.facebook.com/. [Online; accessed 5-October-2012]. [10] Facebook. Facebook apis reference. https://developers.facebook.com/docs/reference/apis/. [On- line; accessed 5-October-2012]. [11] Facebook. Report abuse or policy violations. [12] I. Facebook. Quarterly report pursuant to section 13 or 15(d) of the securities exchange http://www.sec.gov/Archives/edgar/data/1326801/000119312512325997/ act of 1934. d371464d10q.htm#tx371464_14, 2012. [13] Facebook-Newsroom. http://www.facebook.com. [Online; accessed 5-October-2012]. [14] M. Fire, D. Kagan, A. Elisahr, and Y. Elovici. Social privacy protector official website. http://socialprotector.net/, 2012. [Online; accessed 21-September-2012]. [15] M. Fire, D. Kagan, A. Elishar, and Y. Elovici. Social privacy protector-protecting users' privacy in social networks. pages 46 -- 50, 2012. [16] M. Fire, G. Katz, and Y. Elovici. Strangers intrusion detection-detecting spammers and fake profiles in social networks based on topology anomalies. Human Journal, 1(1):26 -- 39, 2012. [17] M. Fire, L. Tenenboim, O. Lesser, R. Puzis, L. Rokach, and Y. Elovici. Link prediction in social networks using computationally efficient topological features. In Privacy, Security, Risk and Trust (PASSAT), 2011 IEEE Third International Conference on and 2011 IEEE Third International Confernece on Social Computing (SocialCom), pages 73 -- 80. IEEE, 2011. [18] Google+. https://plus.google.com/. [Online; accessed 1-September-2012]. [19] R. Guha, R. Kumar, P. Raghavan, and A. Tomkins. Propagation of trust and distrust. In Proceedings of the 13th international conference on World Wide Web, pages 403 -- 412. ACM, 2004. [20] M. Hall, E. Frank, G. Holmes, B. Pfahringer, P. Reutemann, and I. Witten. The weka data mining software: an update. ACM SIGKDD Explorations Newsletter, 11(1):10 -- 18, 2009. [21] I. Kahanda and J. Neville. Using transactional information to predict link strength in online In Proceedings of the Third International Conference on Weblogs and Social social networks. Media (ICWSM), 2009. 25 [22] J. Kuzma. Account creation security of social network sites. International Journal of Applied Science and Technology, 1(3):8 -- 13, 2011. [23] K. Lee, J. Caverlee, and S. Webb. Uncovering social spammers: social honeypots+ machine learn- ing. In Proceeding of the 33rd international ACM SIGIR conference on Research and development in information retrieval, pages 435 -- 442. ACM, 2010. [24] J. Leskovec, D. Huttenlocher, and J. Kleinberg. Predicting positive and negative links in online social networks. In Proceedings of the 19th international conference on World wide web, pages 641 -- 650. ACM, 2010. [25] D. Liben-Nowell and J. Kleinberg. The link-prediction problem for social networks. Journal of the American society for information science and technology, 58(7):1019 -- 1031, 2007. [26] LinkedIn. http://www.linkedin.com/. [Online; accessed 1-September-2012]. [27] Y. Liu, K. Gummadi, B. Krishnamurthy, and A. Mislove. Analyzing facebook privacy settings: User expectations vs. reality. In Proceedings of the 2011 ACM SIGCOMM conference on Internet measurement conference, pages 61 -- 70. ACM, 2011. [28] M. Madden and K. Zickuhr. 65% of online adults use social networking sites. http://pewinternet.org/Reports/2011/Social-Networking-Sites.aspx, 2011. [29] S. Mahmood and Y. Desmedt. Poster: preliminary analysis of google+'s privacy. In Proceedings of the 18th ACM conference on Computer and communications security, pages 809 -- 812. ACM, 2011. [30] S. Nelson, J. Simek, and J. Foltin. The legal implications of social networking. Regent UL Rev., 22:1 -- 481, 2009. [31] Nielsen. The social media report. http://blog.nielsen.com/nielsenwire/social/, 2011. [32] H. Popkin. Facebook app http://www.nbcnews.com/technology/technolog/facebook-app-helps-ferret-out-pedophiles- 871761, 2012. [Online; accessed 21-September-2012]. helps ferret out pedophiles. [33] PrivAware. http://apps.facebook.com/privaware/. [Online; accessed 1-September-2012]. [34] M. Rahman, T. Huang, H. Madhyastha, and M. Faloutsos. Efficient and scalable socware detection in online social networks. In Proceedings of the 21st USENIX conference on Security symposium, pages 32 -- 32. USENIX Association, 2012. [35] M. Rahman, T. Huang, H. Madhyastha, and M. Faloutsos. Frappe: Detecting malicious facebook applications. 2012. [36] ReclaimPrivacy. http://http://www.reclaimprivacy.org//. [Online; accessed 1-September-2012]. [37] T. Sakaki, M. Okazaki, and Y. Matsuo. Earthquake shakes twitter users: real-time event detection by social sensors. In Proceedings of the 19th international conference on World wide web, pages 851 -- 860. ACM, 2010. [38] T. Stein, E. Chen, and K. Mangla. Facebook immune system. In Proceedings of the 4th Workshop on Social Network Systems, page 8. ACM, 2011. [39] G. Stringhini, C. Kruegel, and G. Vigna. Detecting spammers on social networks. In Proceedings of the 26th Annual Computer Security Applications Conference, pages 1 -- 9. ACM, 2010. [40] Twitter. http://www.twitter.com/. [Online; accessed 1-September-2012]. [41] UnitedParents. http://www.unitedparents.com/. [Online; accessed 1-September-2012]. 26 [42] A. Wang. Don't follow me: Spam detection in twitter. In Security and Cryptography (SECRYPT), Proceedings of the 2010 International Conference on, pages 1 -- 10. IEEE, 2010. [43] Z. Yang, C. Wilson, X. Wang, T. Gao, B. Y. Zhao, and Y. Dai. Uncovering social network sybils in the wild. In Proceedings of the 2011 ACM SIGCOMM conference on Internet measurement conference, pages 259 -- 268. ACM, 2011. [44] ZoneAlarm. http://www.zonealarm.com/. [Online; accessed 1-September-2012]. 27
1101.5097
1
1101
2011-01-26T16:15:22
Infinite Multiple Membership Relational Modeling for Complex Networks
[ "cs.SI", "cs.LG", "physics.soc-ph" ]
Learning latent structure in complex networks has become an important problem fueled by many types of networked data originating from practically all fields of science. In this paper, we propose a new non-parametric Bayesian multiple-membership latent feature model for networks. Contrary to existing multiple-membership models that scale quadratically in the number of vertices the proposed model scales linearly in the number of links admitting multiple-membership analysis in large scale networks. We demonstrate a connection between the single membership relational model and multiple membership models and show on "real" size benchmark network data that accounting for multiple memberships improves the learning of latent structure as measured by link prediction while explicitly accounting for multiple membership result in a more compact representation of the latent structure of networks.
cs.SI
cs
Infinite Multiple Membership Relational Modeling for Complex Networks Morten Mørup, Mikkel N. Schmidt and Lars Kai Hansen Cognitive Systems Group Technical University of Denmark {mm,mns,lkh}@imm.dtu.dk Abstract Learning latent structure in complex networks has become an important problem fueled by many types of networked data originating from practically all fields of science. In this paper, we propose a new non-parametric Bayesian multiple- membership latent feature model for networks. Contrary to existing multiple- membership models that scale quadratically in the number of vertices the pro- posed model scales linearly in the number of links admitting multiple-membership analysis in large scale networks. We demonstrate a connection between the sin- gle membership relational model and multiple membership models and show on "real" size benchmark network data that accounting for multiple memberships im- proves the learning of latent structure as measured by link prediction while explic- itly accounting for multiple membership result in a more compact representation of the latent structure of networks. 1 Introduction The analysis of complex networks has become an important challenge spurred by the many types of networked data arising in practically all fields of science. These networks are very different in nature ranging from biology networks such as protein interaction [18, 1] and the connectome of neuronal connectivity [19] to the analysis of interaction between large groups of agents in social and technology networks [14, 19, 9, 20]. Many of the networks exhibit a strong degree of structure; thus, learning this structure facilitates both the understanding of network dynamics, the identification of link density heterogeneities, as well as the prediction of "missing" links. We will represent a network as a graph G = (V, Y) where V = {v1, . . . , vN } is the set of vertices and Y is the set of observed links and non-links. Let Y ∈ {0, 1, ?}N ×N denote a link (adjacency) matrix where the element yij = 1 if there is a link between vertex vi and vj, yij = 0 if there is not a link, and yij =? if the existence of a link is unobserved. Furthermore, let Y1, Y0, and Y? denote the set of links, non-links, and unobserved links in the graph respectively. Over the years, a multitude of methods for identifying latent structure in graphs have been proposed, most of which are based on grouping the vertices for the identification of homogeneous regions. Traditionally, this has been based on various community detection approaches where a community is defined as a densely connected subset of vertices that is sparsely linked to the remaining network [15, 17]. These structures have for instance been identified by splitting the graph using spectral approaches, analyzing flows, and through the analysis of the Hamiltonian. Modularity optimization [15] is a special case that measures the deviation of the fraction of links within communities from the expected fraction of such links based on their degree distribution [15, 17]. A drawback, however, for these types of analyses is that they are based on heuristics and do not correspond to an underlying generative process. 1 PSfrag replacements v1 v2 v3 Y v7 v8 v9 v4 v5 v6 v1 v2 v3 v4 v5 v6 v7 v8 v9 Figure 1: Left: Example of a simple graph where each of the vertices have multiple memberships indicated by colors. Right: The corresponding assignment matrix. Probabilistic generative models: Recently, generative models for complex networks have been proposed where links are drawn according to conditionally independent Bernoulli densities, such that the probability of observing a link yij is given by πij, p(Y Π) = Y (i,j)∈Y πyij ij (1 − πij)1−yij . (1) In the classical Erdos-R´enyi random graph model, each link is included independently with equal probability πij = π0; however, more expressive models are needed in order to model complex latent structure of graphs. In the following, we focus on two related methods: latent class and latent feature models. Latent class models: In latent class models, such as the stochastic block model [16], also denoted the relational model (RM), each vertex vi belongs to a class ci, and the probability, πij, of a link between vi and vj is determined by the class assignments ci and cj as πij = ρcicj . Here, ρkℓ ∈ [0, 1] denotes the probability of generating a link between a vertex in class k and a vertex in class ℓ. Inference in latent class models involves determining the class assignments as well as the class link probabilities. Based on this, communities can be found as (groups of) classes with high internal and low external link probability. In the model proposed by [7] (HW) the class link probability, ρkℓ, is specified by a within-class probability ηc and a between-class probability ηn, i.e ρkℓ = ηn(1 − δkℓ) + ηcδkℓ.. Another intuitive representation, which we refer to as DB, is to have a shared between-class probability but allow for individual within-class probabilities, i.e ρkℓ = ηn(1 − δkℓ) + ηkδkℓ. Both of these representations are consistent with the notion of communities with high internal and low external link density, and restricting the number of interaction parameters can facilitate model interpretation compared to the general RM. Based on the Dirichlet process, [9, 20] propose a non-parametric generalization of the stochastic block model with a potentially infinite number of classes denoted the infinite relational model (IRM) and infinite hidden relational model respectively. The latter generalizing the stochastic block model to simultaneously model potential vertex attributes. Inference in IRM jointly determines the number of latent classes as well as class assignments and class link probabilities. This approach readily generalizes to the HW and DB parameterizations of ρ. Latent feature models: In latent feature models, the assumption that each vertex belongs to a single class is relaxed. Instead it is assumed that each vertex vi has an associated feature zi, and that probabilities of links are determined based on interactions between features. This generalizes the latent class models, which are the special case where the features are binary vectors with exactly one non-zero element. Many latent feature models support the notion of discrete classes, but allow for mixed or multiple memberships (see Figure 1 for an illustration of a network with multiple class memberships). In the mixed membership stochastic block model (MMSB) [1] the vertices are allowed to have fractional class memberships. In binary matrix factorization [11] multiple memberships are explicitly modeled such that each vertex can be assigned to multiple clusters by an infinite latent feature model based on the Indian buffet process (IBP) [6]. [12] study this approach, for the specific case of a Bernoulli likelihood, Eq. (1), and extend the method to include additional side information as covariates in modeling the link probabilities. In their model, the probability of a link πij is specified by πij = 2 fσ (Pkℓ zikzjℓwkℓ + sij ), where fσ(·) is a function with range [0, 1] such as a sigmoid, and wkℓ are weights that affects the probability of generating a link between vertices in cluster k and ℓ. The term sij accounts for bias as well as additional side-information. For example, if covariates φi are available for each vertex vi, [12] suggest including the term sij = βd(φi, φj) + β⊤ i φi + β⊤ j φj, where β, βi, and βj are regression parameters, and d(·, ·) is some possibly nonlinear function. In general, the computational cost of the single membership clustering methods mentioned above scales linearly in the number of links in the graph. Unfortunately, existing multiple membership models [1, 11, 12] scale quadratically in the number of vertices, because they require explicit compu- tations for all links and non-links. This renders existing multiple membership modeling approaches infeasible for large networks. Furthermore, determining the multiple membership assignments is a combinatorial challenge as the number of potential states grow as 2KN rather than K N in single membership models. In particular, standard Gibbs sampling approaches tend to get stuck in local suboptimal configurations where single assignment changes are not adequate for the identification of probable alternative configurations [11]. Consequently, there is both a need for computationally efficient models that scale linearly in the number of links as well as reliable inference schemes for modeling multiple memberships. In this paper, we propose a new non-parametric Bayesian latent feature graph model, denoted the infinite multiple relational model (IMRM), that addresses the challenges mentioned above. Specifi- cally, the contributions in this paper are the following: i) We propose the IMRM in which inference scales linearly in the number of links. ii) We propose a non-conjugate split-merge sampling proce- dure for parameter inference. iii) We demonstrate how the single membership IRM model implicitly accounts for multiple memberships. iv) We compare existing non-parametric single membership models with our proposed multiple membership counterparts in learning latent structure of a variety of benchmark "real" size networks and demonstrate that explicitly modeling multiple-membership results in more compact representations of latent structure. 2 Infinite multiple-membership relational model Given a graph, assume that each vertex vi has an associated K-dimensional binary latent feature vector, zi, with Ki = zi1 assignments. Consider vertex vi and vj: For all KiKj combinations of classes there is an associated probability, ρkℓ, of generating a link. We assume that each of these combinations of classes act independently to generate a link between vi and vj, such that the total probability, πij, of generating a link between vi and vj is given by πij = 1 − (1 − σij )Y kℓ (1 − ρkℓ)zik zjℓ, (2) where σij is an optional term that can be used to account for noise or to include further side- information as discussed previously. Under this model, the features act as independent causes of links, and thus if a vertex gets an additional feature it will result in an increased probability of link- ing to other vertices. In contrast to the model proposed by [12], where negative weights leads to features that inhibit links, our model is more restricted. Although this might result in less power to explain data, we expect that it will be easier to interpret the features in our model because links are directly generated by individual features and not through complex interactions between features. This is analogous to non-negative matrix factorization that is known to form parts-based represen- tation because it does not allow component cancellations [10]. If the latent features zi have only a single active element and σij = 0, Eq. (2) reduces to πij = ρcicj , i.e., the proposed model directly generalizes the IRM model; hence, we denote our model the infinite multiple-membership relational model (IMRM). The link probability model in Eq. (2) has a very attractive computational property. In many real data sets, the number of non-links far exceeds the number of links present in the network. To analyze large scale networks where this holds it is a great advantage to devise algorithms that scale computationally only with the number of links present. As we show in the following, our model has that property. Assuming σij = 0 for simplicity of presentation, we may write Eq. (2) more compactly as πij = 1 − ez⊤ P zj , i 3 where the elements of the matrix P are pkℓ = log(1 − ρkl). Inserting this in Eq. (1) we have iP zji. z⊤ P zj(cid:17)yij (cid:16)ez⊤ P zj(cid:17)1−yij p(Y Z, P ) = Y P zj )i exphX (cid:16)1 − ez⊤ = hY i (1 − ez⊤ i i (3) (i,j)∈Y (i,j)∈Y1 (i,j)∈Y0 The exponent of the second term, which entails a sum over the possibly large set of non-links in the network, can be efficiently computed as pkℓ(cid:16) X kℓ N X i=1 zik N X j=1 zjℓ − X (i,j)∈Y1∪Y? zikzjℓ(cid:17), (4) requiring only summation over links and "missing" links. Assuming that the graph is not dominated by "missing" links, the computation of Eq. (3) scales linearly in the number of graph links, Y1. We presently consider latent binary features zi, but we note that the model scales linearly for any parameterizations of the latent feature vector zi, as long as πij = 1 − ez⊤ P zj ∈ [0; 1] which holds in general if zi is non-negative. As in existing multiple membership models [11, 12] we will assume an unbounded number of la- tent features. We learn the effective number of features through the Indian buffet process (IBP) representation [6], which defines a distribution over unbounded binary matrices, i Z ∼ IBP(α) ∝ αK Qh∈[0,1]N Kh! K Y k=1 (N − mk)!(mk − 1)! N ! (5) where mk is the number of vertices belonging to class k and Kh is the number of columns of Z equal to h. As a prior over the class link probabilities we choose independent Beta distributions, (6) This is a conjugate prior for the single membership models where the parameters akℓ and bkℓ corre- spond to pseudo counts of links and non-links respectively between classes k and ℓ. ρkℓakℓ, bkℓ ∼ Beta(akℓ, bkℓ) ∝ ρakℓ−1 (1−ρkℓ)bkℓ−1. kℓ 2.1 Inference In the following we present a method for inferring the parameters of the model: the infinite binary feature matrix Z and the link probabilities ρkℓ. In the latent class model when only a single feature is active for each vertex, the likelihood in Eq. (3) is conjugate to the Beta prior for ρkℓ. In that case, P can be integrated away and a collapsed Gibbs sampling procedure for Z can be used [9]. This is not possible in the IMRM; instead, we propose to sample P ∼ p(P Z, Y ) using Hamiltonian Markov chain Monte Carlo (HMC), and Z ∼ p(ZP , Y ) using Gibbs sampling combined with split-merge moves. HMC for class link probabilities: Hamiltonian Markov chain Monte Carlo (HMC) [5] is an auxil- iary variable sampling procedure that utilizes the gradient of the log posterior to avoid the random walk behavior of other sampling methods such as Metropolis-Hastings. In the following we do not describe the details of the HMC algorithm, but only derive the required expressions for the gradi- ent. To utilize HMC, the sampled variables must be unconstrained, but since ρkℓ is a probability we make the following change of variable from ρkℓ ∈ [0, 1] to rkℓ ∈ (−∞, ∞), ρkℓ = 1+exp(−rkℓ) , rkℓ = − log(cid:0)ρ−1 kℓ − 1(cid:1). Using the change of variables theorem, the prior for the class link probabil- ities expressed in terms of rkℓ is given by p(rkℓakℓ, bkℓ) ∝ eakℓrkℓ(erkℓ + 1)−(akℓ+bkℓ). With this, the relevant terms of the negative log posterior is given by P zj(cid:17)+X −LP = log p(P Z, Y ) = c+X log(cid:16)1 − ez⊤ iP zj+X z⊤ akℓrkℓ+(akℓ+bkℓ) log(erkℓ+1), 1 i (i,j)∈Y1 (i,j)∈Y0 kℓ where c does not depend on P . From this, the required gradient can be computed, ∂LP ∂rkℓ = − X (i,j)∈Y1 ez⊤ i P zj 1 − ez⊤ i P zj zikzjℓρkℓ + X (i,j)∈Y0 zikzjℓρkℓ + (akℓ + bkℓ)ρkℓ − akℓ. 4 (7) (8) Again, the possibly large sum over non-links in the second term can be computed efficiently as in Eq. (4). Gibbs sampler for binary features: Following [6], a Gibbs sampler for the latent binary features Z can be derived. Consider sampling the kth feature of vertex vi: If one or more other vertices also possess the feature, i.e., m−ik = Pj6=i zjk > 0, the posterior marginal is given by p(zik = 1Z −(ik), P , Y ) ∝ p(Y Z, P ) . (9) m−ik N 1 = Poisson(cid:0)α When evaluating the likelihood term, only the terms that depend on zik need be computed and the Gibbs sampler can be implemented efficiently by reusing computation and by up and down dating variables. In addition to sampling existing features, K (i) N(cid:1) new features should also be associated with vi. [6] suggest ". . . computing probabilities for a range of values of K (i) 1 up to some reasonable upper bound. . . "; however, following [11] we take another approach and sample the new features by Metropolis-Hastings using the prior as proposal density. The values of ρkl corresponding to the new features are proposed from the prior in Eq. (6). Split-merge move for binary features: A drawback of Gibbs sampling procedures is that only a single variable is updated at a time, which makes the sampler prone to get stuck in suboptimal configurations. As a remedy, bolder Metropolis Hasting moves can be considered in which multi- ple changes of assignments help exploring alternative high probability configurations. How these alternative configurations are proposed is crucial in order to attain reasonable acceptance rates. A popular approach is to split or merge existing classes as proposed in [8] for the Dirichlet process mixture model (DPMM). Split-merge sampling in the IBP has previously been discussed briefly by [11] and [12]. Inspired by the non-conjugate sequential allocation split-merge sampler for the DPMM [4], we pro- pose the following procedure: Draw two non-zero elements of Z, (k1, i1) and (k2, i2). If k1 = k2 propose a split -- otherwise propose to merge classes k1 and k2 into a joint cluster k1. Accept the proposal with the Metropolis-Hastings acceptance rate, a∗ = min(cid:16)1, p(Z ∗,P ∗Y )q(ZZ ∗)q(P P ∗) p(Z,P Y )q(Z ∗Z)q(P ∗P ) (cid:17). In case of a merge, we remove k2 and assign all its vertices to k1, and we remove the correspond- ing row and column of P (this proposal is deterministic and has probability one). For a split, we remove all vertices except i1 from cluster k1 = k2 = k and create a new cluster k∗ and assign i2 to it. We then sample a new row and column ρ∗ k′ ℓ′ for the new cluster as described below. Next we sequentially allocate [4] the remaining original members of k to either k or k∗ or both in a restricted Gibbs sampling sweep, and refine the allocation through t additional restricted Gibbs scans [8]. The proposal density for ρ∗ k′ℓ′ is based on a random walk, ρ∗ ¯bk′ℓ′ = max(cid:0)1, (1 − ¯ρk′ ℓ′)m2 k′ℓ′ has mean ¯ρk′ℓ′ and variance equal to the empirical variance, ¯ρk′ℓ′(1 − ¯ρk′ ℓ′)/m2 k − 1 + ¯ρk′ℓ′(cid:1), 1 − ¯ρk′ℓ′ (10) k. We such that ρ∗ k′ℓ′ ∼ Beta(¯ak′ ℓ′, ¯bk′ℓ′), where ¯bk′ℓ′(cid:17), ¯ak′ℓ′ = max(cid:16)1, ¯ρk′ℓ′ ρkk 1 K−1 Pℓ6=k ρkℓ K−1 Pℓ6=k ρℓk ρkℓ 1 ℓ′ = k′ = k∗ k′ = k∗, ℓ′ = k k′ = k, ℓ′ = k∗ otherwise,   choose the mean of the random walk as ¯ρk′ ℓ′ = such that the new class has a similar within and between class link probabilities as the original class, but such that the class link probability between the original and new cluster is similar to the remaining between class link probabilities. This choice is crucial, since it favors splitting classes into two classes that are no more related than the relation to the remaining classes. 3 Results Based on the HW, DB, and RM parametrization of ρ, we compared our proposed IMRM to the corre- sponding single-membership IRM [9]. We evaluated the models on a range of synthetically gener- ated as well as real world networks. We assessed model performance in terms of ability to predict held-out links and non-links. As performance measure we used the area under curve (AUC) of the 5 Y Z ρ Y Z ρ PSfrag replacements PSfrag replacements Figure 2: IRM (upper) and IMRM (lower) analysis of single (left) and multiple membership HW network (right). On the single membership data, both models find the correct class assignments. On the multiple membership data, the IMRM finds the correct 10 classes, while IRM extracts 25 classes, which through ρ accounts for all combinations of classes present in the data. HW DB RM MHW MDB MRM 1 0.8 0.6 0.4 C A J P G E D N M O C P H S W H B D M R I I I W H M B D M M R M I I I C A J P G E D N M O C P H S W H B D M R I I I W H M B D M M R M I I I N M O C C A J P G E D P H S W H B D M R I I I W H M B D M M R M I I I C A J P G E D N M O C P H S W H B D M R I I I W H M B D M M R M I I I C A J P G E D N M O C P H S W H B D M R I I I W H M B D M M R M I I I N M O C C A J P G E D P H S W H B D M R I I I W H M B D M M R M I I I Figure 3: AUC scores for the analysis of the six synthetically generated data sets. receiver operating characteristic (ROC). We also computed the predictive log likelihood (not shown here) which gave similar results. For comparison, we included the performance of several standard non-parametric link prediction approaches based on the following scores, γComN i,j = y⊤ i yj, γDegPr i,j = kikj , γJacc i,j = y⊤ i yj ki + kj − y⊤ i yj , γShP i,j = 1 minp{(Y p)i,j > 0} , where ki = Pj yij is the degree of vertex vi. In all the analyses we removed 2.5% of the links and an equivalent number of non-links for cross- validation. We analyzed a total of five random data splits and all of the analyses were based on 2500 sampling iterations initialized randomly with K = 50 clusters. Each iteration was based on split-merge sampling using sequential allocation with t = 2 restricted Gibbs scans followed by standard Gibbs sampling. Our implementation of the IRM was based on collapsed Gibbs sampling (i.e. integrating out ρ) as proposed in [9] but we also included a conjugate single-membership split-merge step corresponding to the proposed non-conjugate split-merge sampler. The priors were chosen as α = log(N ), akk = 5, akℓ = 1∀k 6= ℓ and bkk = 1, bkℓ = 5∀k 6= ℓ which renders the priors practically non-informative. Synthetic networks: We analyzed a total of six synthetic networks generated according to the HW, DB and RM models based on the vertices having either one or two memberships to the underlying classes. For the single membership models we generated a total of K = 5 groups each containing 100 vertices. For the HW generated network we set ρc = 1 and ρ0 = 0 while for the DB generated network we used a within community densities ρk ranging from 0.2 to 1 while ρ0 = 0. The RM generated network had same within community densities as the DB network but included varying degrees of overlap between the communities. The multiple membership models denoted MHW, MDB and MRM were generated from the corresponding single membership models as Y ∨RY R⊤ (where ∨ denotes element-wise or and R is a random permutation matrix with diagonal zero), such that each vertex belongs to two classes. While the IMRM model explicitly accounts for multiple memberships, the IRM model can also im- plicitly account for multiple memberships through the between class interactions. To illustrate this, we analyzed the generated HW and MHW data by the IRM model as well as the proposed IMRM model (see Figure 2). When there are only single memberships, the IMRM reduces to the IRM model; however, when the network is generated such that the vertices have multiple memberships the IMRM model correctly identifies the (2 · 5 = 10) underlying classes. The IRM model on the other hand extracts a larger number of classes corresponding to all possible (52 = 25) combinations of classes present in the data. The estimated ρ indicates how these 25 classes combine to form the 6 Yeast USPower Erdos FreeAssoc Reuters911 1 0.8 0.6 0.4 N M O C C A J P G E D P H S W H B D I M R I I W H M I B D M I M R M I N M O C C A J P G E D P H S W H B D I I M R I W H M I B D M I M R M I N M O C C A J P G E D P H S W H B D I M R I I W H M I B D M I M R M I N M O C C A J P G E D P H S W H B D I I M R I W H M I B D M I M R M I P H S W H B D I M R I I W H M I B D M I M R M I N M O C C A J P G E D Figure 4: AUC scores for the analysis of the five real networks. Table 1: Summary of the analyzed real networks: r denotes the networks assortativity, c the cluster- ing coefficient [19], L the average shortest path. NETWORK Yeast USPower Erdos FreeAssoc Reuters911 N 2,284 4,941 5,534 10,299 13,314 Y1 6,646 6,594 8,472 61,677 148,038 r -0.10 0.00 -0.04 -0.07 -0.11 c 0.13 0.08 0.08 0.12 0.37 Description Protein-protein interaction network [18] Topology of power grid [19] Erdos 02 collaboration network [2] L 4.4 19.9 3.9 3.9 Word relations in free association [13] 3.1 Word co-occurence [3] 10 underlying multiple membership groups in the network. As such, the IRM model has the same expressive power as the proposed multiple membership models but interpreting the results can be difficult when multiple membership community structure is split into several classes with complex patterns of interaction. Figure 3 shows the link-prediction AUC scores from the analysis of the six generated networks. Results show that all models work well on data generated according to their own model or models which they generalize. We also notice, that the IRM model accounts well for multiple membership structure as discussed and illustrated in Figure 2. The HW and DB models on the other hand fail in modeling networks with multiple memberships. Real Networks: We finally analyzed five benchmark complex networks summarized in Table 1. The sizes of most of the networks makes it computationally infeasible for us to analyze them using the existing multiple-membership approaches proposed in [1, 11, 12]. For all the networks, multiple memberships are conceivable: In protein interaction networks such as the Yeast network proteins can be part of multiple functional groups, in social networks such as Erdos scientist collaborate with different groups of people depending on the research topic, and in word relation networks such as Reuters911 and FreeAssoc words can have multiple meanings/contexts. For all these networks explicitly modeling these multiple contexts can potentially improve on the structure identification over the equivalent single membership models. In Figure 4 the AUC link prediction score is given for the five networks analyzed. As can be seen from the results, modeling multiple memberships significantly improves on predicting links in the network. In particular when considering the IHW and IDB models and the corresponding proposed multiple membership models, the learning of structure is improved substantially for all networks except USPower. Furthermore, it can be seen that the IRM model that can also implicitly account for multiple memberships in general has a similar performance to the multiple membership models. The poor identification of structure in the USPower network might be due to the fact that the average Table 2: Top table: The number of extracted components for the IRM and IMRM models. Bold denotes that the number of components are significantly different between the two models (i.e. difference in mean is at least two standard deviations apart). Bottom table: cpu-time usage in hours for 2500 IRM and IMRM sampling iterations. USPower 8.6 ± 0.4 6.8 ± 0.5 IRM 24.0 ± 0.8 IMRM 15.4 ± 0.9 FreeAssoc 58.6 ± 0.7 15.6 ± 0.9 Reuters911 39.8 ± 2.1 44.8 ± 1.0 10.4 ± 0.3 6.8 ± 0.6 Erdos Yeast Yeast IRM 2.3 ± 0.1 IMRM 1.7 ± 0.1 USPower 4.0 ± 0.2 8.9 ± 0.8 Erdos 14.6 ± 5.9 7.1 ± 0.5 FreeAssoc 30.1 ± 0.6 28.1 ± 1.9 Reuters911 32.5 ± 5.4 71.5 ± 3.2 7 path between vertices are very high rendering it difficult to detect the underlying structure for any but the most simple IHW model. While the IRM and IMRM perform equally well in terms of link prediction it can be seen in table 2 that the average number of extracted components for the IMRM model is significantly smaller than the number of components extracted by the IRM model for all networks except the Reuters911 network where no significant difference is found. As a result, the IMRM model is in general able to extract a more compact representation of the latent structure of networks. In table 2 is given the total cpu-time for estimating the 2500 samples for each of the network using the IRM and IMRM showing that the order of magnitude for the computational cost of the two models are the same. 4 Discussion While single membership models based on the IRM indirectly can account for multiple memberships as we have shown, the benefit of the proposed framework is that it allows for these multiple mem- berships to be modeled explicitly rather than through complex between-group interactions based on a multitude of single membership components. On synthetic and real data we demonstrated that explicitly modeling multiple-membership resulted in a more compact representation of the inherent structure in networks. We further demonstrated that models that can capture multiple memberships (which includes the IRM model) significantly improve on the link prediction relative to models that can only account for single membership structure, i.e., the IHW and IDB models. We presently con- sidered undirected networks but we note that the proposed approach readily generalizes to directed and bi-partite graphs. Furthermore, the approach also extends to include side information as pro- posed in [12] as well as simultaneous modeling of vertex attributes [20]. We note however, that the inclusion of side information requires a linearly scalable parameterization in order for the overall model to remain computationally efficient. An attractive property of the IRM model over the IMRM model is that the IRM model admits the use of collapsed Gibbs sampling which we have found to be more efficient relative to sampling the non-conjugate multiple membership models where additional sampling of the ρ parameter is required. In future research, we envision combining the IRM and IMRM model, using the IRM as initialization for the IMRM or by forming hybrid models. References [1] E. M. Airoldi, D. M. Blei, S. E. Fienberg, and E. P. Xing. Mixed membership stochastic blockmodels. J. Mach. Learn. Res., 9:1981 -- 2014, 2008. [2] V. Batagelj and A. Mrvar. Pajek data sets, 2006. [3] S. R. Corman, T. Kuhn, R. D. McPhee, and D. K. J. Studying complex discursive systems: Centering resonance analysis of communica- tion. Human communication research, 28(2):157 -- 206, 2002. [4] D. B. Dahl. Sequentially-allocated merge-split sampler for conjugate and nonconjugate Dirichlet process mixture models. Technical report, Texas A&M University, 2005. [5] S. Duane, A. D. Kennedy, B. J. Pendleton, and D. Roweth. Hybrid monte carlo. Physics Letters B, 195(2):216 -- 222, 1987. [6] T. L. Griffiths and Z. Ghahramani. Infinite latent feature models and the Indian buffet process. In Neural Information Processing Systems, Advances in (NIPS), pages 475 -- 482, 2006. [7] J. M. Hofman and C. H. Wiggins. Bayesian approach to network modularity. Physical Review Letters, 100(25), Jun 2008. [8] S. Jain and R. M. Neal. A split-merge markov chain monte carlo procedure for the dirichlet process mixture model. Journal of Compu- tational and Graphical Statistics, 13(1):158 -- 182, 2004. [9] C. Kemp, J. B. Tenenbaum, T. L. Griffiths, T. Yamada, and N. Ueda. Learning systems of concepts with an infinite relational model. In Artificial Intelligence, Proceedings of the National AAAI Conference on, 2006. [10] D. D. Lee and H. S. Seung. Learning the parts of objects by non-negative matrix factorization. Nature, 401(6755):788 -- 791, 1999. [11] E. Meeds, Z. Ghahramani, R. M. Neal, and S. T. Roweis. Modeling dyadic data with binary latent factors. In Advances in Neural Information Processing Systems (NIPS), volume 19, pages 977 -- 984, 2007. [12] K. T. Miller, T. L. Griffiths, and M. I. Jordan. Nonparametric latent feature models for link prediction. In Advances in Neural Information Processing Systems (NIPS), pages 1276 -- 1284, 2009. [13] D. L. Nelson, C. L. McEvoy, and T. A. Schreiber. The university of south florida word association, rhyme, and word fragment norms, 1998. [14] M. E. J. Newman. The structure of scientific collaboration networks. PNAS, 98(2):404 -- 409, 2001. [15] M. E. J. Newman and M. Girvan. Finding and evaluating community structure in networks. Phys. Rev. E, 69(2):026113 -- 1 -- 15., 2004. [16] K. Nowicki and T. A. B. Snijders. Estimation and prediction for stochastic blockstructures. Journal of the American Statistical Associa- tion, 96(455):1077 -- 1087, 2001. [17] J. Reichardt and S. Bornholdt. Statistical mechanics of community detection. Physical Review E, 74(1), 2006. [18] S. Sun, L. Ling, N. Zhang, G. Li, and R. Chen. Topological structure analysis of the protein-protein interaction network in budding yeast. Nucleic Acids Research, 31(9):2443 -- 2450, 2003. [19] D. J. Watts and S. H. Strogatz. Collective dynamics of 'small-world' networks. Nature, 393(6684):440 -- 442, June 1998. [20] Z. Xu, V. Tresp, K Yu, and H.-P. Kriegel. Learning infinite hidden relational models. Uncertainity in Artificial Intelligence (UAI2006), 2006. 8
1903.00605
1
1903
2019-03-02T02:11:25
On Fractional Approach to Analysis of Linked Networks
[ "cs.SI" ]
In this paper, we present the outer product decomposition of a product of compatible linked networks. It provides a foundation for the fractional approach in network analysis. We discuss the standard and Newman's normalization of networks. We propose some alternatives for fractional bibliographic coupling measures.
cs.SI
cs
On Fractional Approach to Analysis of Linked Networks Vladimir Batagelj1,2,3 ORCID: 0000-0002-0240-9446 1Institute of Mathematics, Physics and Mechanics, Jadranska 19, 1000 Ljubljana, Slovenia 2University of Primorska, Andrej Marusic Institute, 6000 Koper, Slovenia 3 National Research University Higher School of Economics, Myasnitskaya, 20, 101000 Moscow, Russia. [email protected] phone: +386 1 434 0 111 March 5, 2019 Abstract In this paper, we present the outer product decomposition of a product of compatible linked networks. It provides a foundation for the fractional approach in network analysis. We discuss the standard and Newman's normalization of networks. We propose some al- ternatives for fractional bibliographic coupling measures. Keywords: social network analysis, linked networks, bibliographic networks, network multiplication, fractional approach, Newman's normalization, bibliographic coupling. MSC: 01A90, 91D30, 90B10, 65F30, 65F35 JEL: C55, D85 1 Introduction The fractional approach was proposed by Lindsey (1980). For example in the analysis of coau- thorship the contributions of all coauthors to a work has to add to 1. Usually the contribution is then estimated as 1 divided by the number of coauthors. An alternative rule, Newman's normal- ization, was given in Newman (2001) and Newman (2004) which excludes the selfcollaboration. Recently several papers (Batagelj and Cerinsek, 2013; Cerinsek and Batagelj, 2015; Perianes- Rodriguez et al., 2016; Prathap and Mukherjee, 2016; Leydesdorff and Park, 2017; Gauffriau, 2017) reconsidered the background of the fractional approach. The details are presented and discussed in Subsection 6.2. In this paper we propose a theoretical framework based on the outer product decomposition to get the insight into the structure of bibliographic networks obtained with network multiplication. 1 2 Linked networks Linked or multi-modal networks are collections of networks over at least two sets of nodes (modes) and consist of some one-mode networks and some two-mode networks linking dif- ferent modes. For example: modes are Persons and Organizations. Two one-mode networks describe collaboration among Persons and among Organizations. The linking two-mode net- work describes membership of Persons to different Organizations. Linked networks are the basis of the MetaMatrix approach developed by Krackhardt and Carley (Krackhardt and Carley, 1998; Carley, 2003). For an example see the Table 3 in Diesner and Carley (2004, p. 89). Another example of linked networks are bibliographic networks. From special bibliogra- phies (BibTEX) and bibliographic services (Web of Science, Scopus, SICRIS, CiteSeer, Zen- tralblatt MATH, Google Scholar, DBLP Bibliography, US patent office, IMDb, and others) we can construct some two-mode networks on selected topics: authorship on works × authors (WA), keywordship on works × keywords (WK), journalship on works × journals/publishers (WJ), and from some data also the classification network on works × classification (WC) and the one-mode citation network on works × works (Ci); where works include papers, reports, books, patents, movies, etc. Besides this we get also the partition of works by the publication year, and the vector of number of pages (WoS, 2018; Batagelj, 2007). An important tool in analysis of linked networks is the use of derived networks obtained by network multiplication. 3 Network multiplication Given a pair of compatible two-mode networks NA = (I,K,AA, wA) and NB = (K,J ,AB, wB) with corresponding matrices AI×K and BK×J we call a product of networks NA and NB a net- work NC = (I,J ,AC, wC), where AC = {(i, j) : i ∈ I, j ∈ J , ci,j (cid:54)= 0} and wC(i, j) = ci,j for (i, j) ∈ AC. The product matrix C = [ci,j]I×J = A · B is defined in the standard way (cid:88) k∈K ci,j = ai,k · bk,j In the case when I = K = J we are dealing with ordinary one-mode networks (with square matrices). In the following we will often identify networks by their matrices. In the paper Batagelj and Cerinsek (2013) it is shown that ci,j is equal to the value of all two step paths from i ∈ I to j ∈ J passing through K. In a special case, if all weights in networks NA and NB are equal to 1 the value of ci,j counts the number of ways we can go from i ∈ I to B (j); where NA(i) is the set of nodes in K linked j ∈ J passing through K: ci,j = NA(i) ∩ N− B (j) is the set of nodes in K linked by arcs to by arcs from node i in the network NA, and N− node j in the network NB. The standard matrix multiplication has the complexity O(I · K · J ) -- it is too slow to be used for large networks. For sparse large networks we can multiply much faster considering only nonzero elements. 2 Figure 1: WAT · WK for k in K do for (i, j) in N− A (k) × NB(k) do if ∃ci,j then ci,j := ci,j + ai,k · bk,j else new ci,j := ai,k · bk,j In general the multiplication of large sparse networks is a 'dangerous' operation since the result can 'explode' -- it is not sparse. If for the sparse networks NA and NB there are in K only few nodes with large degree and no one among them with large degree in both networks then also the resulting product network NC is sparse. From the network multiplication algorithm we see that each intermediate node k ∈ K adds to a product network a complete two-mode subgraph KN− A (k),NB(k) (or, in the case B = AT , where AT is the transposition of A, a complete subgraph KN (k)). If both degrees degA(k) = N− A (k) and degB(k) = NB(k) are large then already the computation of this complete sub- graph has a quadratic (time and space) complexity -- the result 'explodes'. For details see the paper Batagelj and Cerinsek (2013). 4 Outer product decomposition For vectors x = [x1, x2, . . . , xn] and y = [y1, y2, . . . , ym] their outer product x ◦ y is defined as a matrix x ◦ y = [xi · yj]n×m then we can express the previous observation about the structure of product network as the outer product decomposition C = A · B = Hk where Hk = A[k,·] ◦ B[k,·] (cid:88) For binary (weights) networks we have Hk = KN− A (k),NB(k). k 3 a1a2a3a4w1w2w3w4w5k1k2k3k4Pajek Example A: As an example let us take the binary network matrices WA and WK: and compute the product H = WAT · WK. We get a network matrix H which can be decom- posed as  WA = w1 w2 w3 w4 w5 a1 1 1 1 0 1 a2 0 1 0 1 0 a3 1 0 1 0 1 a4 0 0 1 1 1   H a1 a2 a3 a4 H3 a1 a2 a3 a4 k1 2 1 1 0 k1 0 0 0 0 k2 3 0 3 2 k2 1 0 1 1 k3 2 2 1 2 k3 1 0 1 1 k4 2 0 2 2 k4 1 0 1 1  =  +   H1 a1 a2 a3 a4 H4 a1 a2 a3 a4 k1 1 0 1 0 k1 0 0 0 0 w1 w2 w3 w4 w5 , WK =  +  + k3 0 0 0 0 k4 0 0 0 0 k2 1 0 1 0 k2 0 0 0 0 k3 0 1 0 1 k4 0 0 0 0  k1 1 1 0 0 0 k2 1 0 1 0 1 k3 0 1 1 1 0 k4 0 0 1 0 1    H2 a1 a2 a3 a4 H5 a1 a2 a3 a4 k1 1 1 0 0 k1 0 0 0 0 k2 0 0 0 0 k2 1 0 1 1 k3 1 1 0 0 k3 0 0 0 0 k4 0 0 0 0 k4 1 0 1 1 +  5 Derived networks We can use the multiplication to obtain new networks from existing compatible two-mode net- works. For example, from basic bibliographic networks WA and WK we get AK = WAT · WK a network relating authors to keywords used in their works, and Ca = WAT · Ci · WA is a network of citations between authors. Networks obtained from existing networks using some operations are called derived net- works. They are very important in analysis of collections of linked networks. What is the meaning of the product network? In general we could consider weights, addition and multiplication over a selected semiring (Cerinsek and Batagelj, 2017). In this paper we will limit our attention to the traditional addition and multiplication of real numbers. The weight AK[a, k] is equal to the number of times the author a used the keyword k in his/her works. The weight Ca[a, b] counts the number of times a work authored by the author a is citing a work authored by the author b; or shorter, how many times the author a cited the author b. 4 Using network multiplication we can also transform a given two-mode network, for example WA, into corresponding ordinary one-mode networks (projections) WW = WA · WAT and AA = WAT · WA The obtained projections can be analyzed using standard network analysis methods. This is a traditional recipe how to analyze two-mode networks. Often the weights are not considered in the analysis; and when they are considered we have to be very careful about their meaning. The weight WW[p, q] is equal to the number of common authors of works p and q. The weight AA[a, b] is equal to the number of works that author a and b coauthored. In a special case when a = b it is equal to the number of works that the author a wrote. The network AA is describing the coauthorship (collaboration) between authors and is also denoted as Co -- the "first" coauthorship network. In the paper Batagelj and Cerinsek (2013) it was shown that there can be problems with the network Co when we try to use it for identifying the most collaborative authors. By the outer product decomposition the coauthorship network Co is composed of complete subgraphs on the set of work's coauthors. Works with many authors produce large complete subgraphs, thus bluring the collaboration structure, and are over-represented by its total weight. To see this, let j yj then the contribution of the outer product x ◦ y is equal (x ◦ y)ij = xi ·(cid:88) yj = Sx · Sy xi · yj = (cid:88) (cid:88) (cid:88) i j i j Sx =(cid:80) i xi and Sy =(cid:80) (cid:88) total weight T (Hw) =(cid:80) T = i,j In general each term Hw in the outer product decomposition of the product C has different a,k(Hw)ak leading to over-representation of works with large values. In the case of coautorship network Co we have S(WA[w, .]) = outdegWA(w) and therefore T (Hw) = outdegWA(w)2. To resolve the problem we apply the fractional approach. 6 Fractional approach To make the contributions of all works equal we can apply the fractional approach by normal- izing the weights: setting x(cid:48) = x/Sx and y(cid:48) = y/Sy we get Sx(cid:48) = Sy(cid:48) = 1 and therefore T (H(cid:48) w) = 1 for all works w. In the case of two-mode networks WA and WK we denote (cid:40)(cid:80) 1 SWA w = a WA[w, a] outdegWA(w) > 0 outdegWA(w) = 0 (and similarly SWK w ) and define the normalized matrices WAn = diag( 1 SWA w ) · WA, WKn = diag( ) · WK 1 SWK w w =(cid:80) In real life networks WA (or WK) it can happen that some work has no author. In such a case a WA[w, a] = 0 which makes problems in the definition of the normalized network SWA WAn. We can bypass the problem by setting SWA w = 1, as we did in the above definition. 5 Then the normalized product matrix is AKt = WAnT · WKn 1 SWA w SWK w Hw the outer product decomposition gets form (cid:88) w AKt = Fw Denoting Fw = Since (cid:40) 1 0 T (Fw) = (outdegWA(w) > 0) ∧ (outdegWK(w) > 0) (cid:88) (cid:88) otherwise we have further (cid:88) where W + = {w ∈ W : (outdegWA(w) > 0) ∧ (outdegWK(w) > 0)}. T (Fw) = W + (cid:88) Fw[a, k] = F[a, k] = a,k a,k w w In the network AKt the contribution of each work to the bibliography is 1. These contribu- tions are redistributed to arcs from authors to keywords. Example B: For matrices from Example A we get the corresponding diagonal normalization matrices compute the normalized matrices  WAn = w1 w2 w3 w4 w5 a2 a1 1/2 0 1/2 1/2 0 1/3 0 1/2 0 1/3 a4 a3 0 1/2 0 0 1/3 1/3 0 1/2 1/3 1/3 , k3 0 1/2 k4 k1 k2 0 1/2 1/2 0 1/2 0 1/3 1/3 1/3 0 0 0 0 1/2 1/2 0 1 0 diag( 1 SWA w ) = w1 w2 w3 w4 w5 diag( 1 SWK w ) =   w1 w2 w3 w4 w5   w5 0 0 0 0 1/3 w5 0 0 0 0 1/2 w1 1/2 0 0 0 0 w2 0 1/2 0 0 0 w3 0 0 1/3 0 0 w4 0 0 0 1/2 0 w1 1/2 0 0 0 0 w2 0 1/2 0 0 0 w3 0 0 1/3 0 0 , WKn = w1 w2 w3 w4 w5 w4 0 0 0 1 0  6 outer products such as F1 = a1 a2 a3 a4  k2 k3 k1 1/4 1/4 0 0 0 1/4 1/4 0 0 0 0 0 k4 0 0 0 0 and finally the product matrix AKt = WAnT · WKn = 5(cid:88) w=1 Fw =  a1 a2 a3 a4   a1 a2 a3 a4 F5 = k2 k3 k1 k4 0 1/6 0 1/6 0 0 0 1/6 0 1/6 0 1/6 0 1/6 0 0  k1 k2 k3 k4 0.50000 0.52778 0.36111 0.27778 0.25000 0.00000 0.75000 0.00000 0.25000 0.52778 0.11111 0.27778 0.00000 0.27778 0.61111 0.27778  6.1 Linking through a network Let a network S links works to works. The derived network WAT · S · WA links authors to authors through S. Again, the normalization question has to be addressed. Among different options let us consider the derived networks defined as: C = WAnT · S · WAn It is easy to verify that: • if S is symmetric, ST = S, then also C is symmetric, CT = C; CT = (WAnT · S · WAn)T = WAnT · ST · (WAnT )T = C • if W + = {w ∈ W : outdegWA(w) > 0} = W , the total of weights of S is redistributed (cid:88) (cid:88) T (C) = c(e) = e∈L(C) e∈L(S) wa[p, a] = outdegWA(p) and wan[p, a] = in C: Since (cid:88) a∈A we get (cid:88) = (cid:88) (cid:88) e∈L(C) (cid:88) (cid:88) a∈A b∈A s[p, q] outdegWA(p)outdegWA(q) p∈W + q∈W + and finally, if W + = W (cid:88) (cid:88) p∈W + q∈W + s[p, q] = 7 T (C) = c(e) = c[a, b] = wan[p, a] · s[p, q] · wan[q, b] = outdegWA(p) 0 s(e) = T (S) (cid:40) wa[p,a] (cid:88) (cid:88) q∈W b∈A s(e) = T (S) (cid:88) p∈W (cid:88) (cid:88) (cid:88) a∈A b∈A a∈A (cid:88) e∈L(S) outdegWA(p) > 0 otherwise (cid:88) (cid:88) p∈W + q∈W + wa[p, a] wa[q, b] = s[p, q] As special cases we get for normalized author's citation networks with W + = W : for (cid:88) (cid:88) p∈W q∈W c[a, b] = ci[p, q] = Ci S = Ci and for S = Cin(cid:88) (cid:88) c[a, b] = (cid:88) (cid:88) a∈A (cid:88) (cid:88) b∈A a∈A b∈A p∈W q∈W : outdegCi(q)>0 (cid:88) q∈W : outdegCi(q)>0 1 = W + Ci ci[p, q] outdegCi(p) = 6.2 Some notes A. Instead of computing the normalized network WAn from the network WA we could collect the data about the real proportion wan[w, a] of the contribution of each author a to a work w such that WAn is normalized: for every work w it holds (cid:88) a∈A wan[w, a] ∈ {0, 1} Unfortunately in most cases such data are not available and we use the computed normalized weights as their estimates. Most of the results do not depend on the way the normalized network was obtained. (cid:40)(cid:80) 1 In general a given network matrix WA can be normalized in two ways: by rows, as used in B. this section, and by columns WAn(cid:48) = WA · diag( 1 SWA a ) where SWA a = w WA[w, a] indegWA(a) > 0 indegWA(a) = 0 In the context of bibliographic networks its meaning does not make much sense. C. The network Co is symmetric: coab = coba. We need to compute only half of values coab, a ≤ b. The resulting network is undirected with weights coab. In the paper Batagelj and Cerinsek (2013) the "second" coauthorship network Cn = WAT· D. WAn is considered. The weight cnab is equal to the contribution of an author a to works that (s)he wrote together with the author b. Using these weights the selfsufficiency of an author a is defined as: and collaborativness of an author a as its complementary measure Ka = 1 − Sa. Sa = cnaa indegWA(a) 8 In the "third" coauthorship network Cn = WAnT · WAn the weight ctab is equal to the E. total fractional contribution of 'collaboration' of authors a and b to works. Each work w with w > 0 contributes 1 to the total of weights in Cn. This is the network to be used in analysis SWA of collaboration between authors (Batagelj and Cerinsek, 2013; Leydesdorff and Park, 2017; Prathap and Mukherjee, 2016). To identify the most collaborative groups we can use methods such as PS-cores and link islands (Batagelj et al., 2014). The product Cn is symmetric. Note C applies. We transform it to the corresponding undi- rected network -- pairs of opposite arcs are replaced by an edge with doubled weight. In analyses we usually analyze separately the vector of weights on loops (selfcontribution) and the network Cn without loops. F. An alternative normalization WAn(cid:48) of a binary autorship matrix WA was proposed in New- man (2004) wan(cid:48) wa = wawa max(1, outdegWA(w) − 1) in which only collaboration with coauthors is considered -- no selfcollaboration. Note that using the network construction proposed on page 5 of Newman (2001) we get a network in which works with many coauthors are still over-represented. The same idea is used in the fractional counting co-authorship matrix U∗ proposed in equation (5) in Perianes-Rodriguez et al. (2016). To treat all works equally using the Newman's normalization the "fourth" coauthorship network was proposed in Cerinsek and Batagelj (2015). To compute it we first compute Ct(cid:48) = WAnT · WAn(cid:48) The weight ct(cid:48) ab is equal to the total contribution of "strict collaboration" of authors a and b to works. The obtained product is symmetric. Again note C applies. We transform it to the corresponding undirected network -- pairs of opposite arcs are replaced by an edge with doubled weight. The loops are removed. The contribution of each work with at least two coauthors is equal to 1. A kind of the outer product decomposition exists also for the network Ct(cid:48) with a diagonal set to 0. 7 Bibliographic Coupling and Co-citation Bibliographic coupling occurs when two works each cite a third work in their bibliographies, see Figure 2, left. The idea was introduced by Kessler (1963) and has been used extensively since then. See figure where two citing works, p and q, are shown. Work p cites five works and q cites seven works. The key idea is that there are three works cited by both p and q. This suggests some content communality for the three works cited by both p and q. Having more works citing pairs of prior works increases the likelihood of them sharing content. We assume that the citation relation means p Ci q ≡ work p cites work q. Then the biblio- graphic coupling network biCo can be determined as biCo = Ci ∗ CiT 9 Figure 2: Bibliographic coupling (left) and Co-citation (right) The weight bicopq is equal to the number of works cited by both works p and q; bicopq = Ci(p) ∩ Ci(q). Bibliographic coupling weights are symmetric: bicopq = bicoqp: biCoT = (Ci · CiT )T = Ci · CiT = biCo Co-citation is a concept with strong parallels with bibliographic coupling (Small and Mar- shakova 1973), see Figure 2, right. The focus is on the extent to which works are co-cited by later works. The basic intuition is that the more earlier works are cited, the higher the likelihood that they have common content. The co-citation network coCi can be determined as coCi = CiT · Ci. The weight cocipq is equal to the number of works citing both works p and q. The network coCi is symmetric cocipq = cociqp: coCiT = (CiT · Ci)T = CiT · Ci = coCi An important property of co-citation is that coCi(Ci) = biCo(CiT ): biCo(CiT ) = CiT · (CiT )T = CiT · Ci = coCi(Ci) Therefore the constructions proposed for bibliographic coupling can be applied also for co- citation. What about normalizations? Searching for the most coupled works we have again problems with works with many citations, especially with review papers. To neutralize their impact we can introduce normalized measures. The fractional approach works fine for normalized co- citation where Cin = D· Ci and D = diag( work has value 1 and it is equally distributed to all cited works. CoCit = CinT · Cin max(1,outdeg(p))). DT = D . In the normalized network every 1 The fractional approach can not bi directly applied to bibliographic coupling -- to get the outer product decomposition work we would need to normalize Ci by columns -- a cited work has value 1 which is distributed equally to the citing works -- the most cited works give the least. This is against our intuition. To construct a reasonable measure we can proceed as follows. Let us first look at biC = Cin · CiT 10 we have biC = (D · Ci) · CiT = D · biCo biCT = (D · biCo)T = biCoT · DT = biCo · D For Ci(p) (cid:54)= ∅ and Ci(q) (cid:54)= ∅ it holds Ci(p) ∩ Ci(q) biCpq = Ci(p) and biCqp = Ci(p) ∩ Ci(q) Ci(q) = biCT pq and biCpq ∈ [0, 1]. biCpq is the proportion of its references that the work p shares with the work q. The network biC is not symmetric. We have different options to construct normalized symmetric measures such as biCoapq = 1 2 (biCpq + biCqp) Average biCompq = min(biCpq, biCqp) Minimum biCoMpq = max(biCpq, biCqp) Maximum or, may be more interesting biCogpq =(cid:112)biCpq · biCqp = Ci(p) ∩ Ci(q) (cid:112)Ci(p) · Ci(q) Geometric mean Salton cosinus biCohpq = 2 · (biC−1 pq + biC−1 qp )−1 = 2Ci(p) ∩ Ci(q) Ci(p) + Ci(q) Harmonic mean biCojpq = (biC−1 pq + biC−1 qp − 1)−1 = Ci(p) ∩ Ci(q) Ci(p) ∪ Ci(q) Jaccard index All these measures are similarities. It is easy to verify that biCoXpq ∈ [0, 1] and: biCoXpq = 1 iff the works p and q are referencing the same works, Ci(p) = Ci(q). From m ≤ H ≤ G ≤ A ≤ M and J ≤ m, (P∩Q P∩Q Q )) we get biCojpq ≤ biCompq ≤ biCohpq ≤ biCogpq ≤ biCoapq ≤ biCoMpq P∪Q ≤ min( P∩Q P , The equalities hold iff Ci(p) = Ci(q). dis = − log sim. For example To get a dissimilarity we can use transformations dis = 1 − sim or dis = 1 sim − 1 or biCodpq = 1 − biCojpq = Ci(p) ⊕ Ci(q) Ci(p) ∪ Ci(q) Jaccard distance where ⊕ denotes the symmetric difference of sets. Bibliographic coupling and co-citation networks are linking works to works. To get linking between authors, journals or keywords considering citation similarity we can apply the con- struction from Subsection 6.1 to the normalized co-citation or bibliographic coupling network. 11 8 Conclusions In the paper we presented an attempt to provide a foundation of fractional approach to biblimet- ric networks based on the outer product decomposition of product networks. We also discussed the fractional approach to bibliographic coupling and co-citation networks. The results of appli- cation of the proposed methods to real bibliographic data will be presented in separate papers. All described computations can be done efficiently in program Pajek (De Nooy et al., 2018) using macros such us: norm1 -- normalized 1-mode network, norm2 -- normalized 2-mode network, norm2p -- Newman's normalization of a 2-mode network, biCo -- bibliographic cou- pling network, and biCon -- normalized bibliographic coupling network, available at GitHub (Batagelj, 2018). Acknowledgments The paper is based on presentations on 1274. Sredin seminar, IMFM, Ljubljana, 29. March 2017; NetGloW 2018, St Petersburg, July 4-6, 2018; and COMPSTAT 2018, Iasi, Romania, August 28-31, 2018. This work is supported in part by the Slovenian Research Agency (research program P1- 0294 and research projects J1-9187, J7-8279 and BI-US/17-18-045), project CRoNoS (COST Action IC1408) and by Russian Academic Excellence Project '5-100'. References Batagelj, V. (2018). Github: biblio -- Bibliographic network analysis. https://github.com/bavla/biblio Batagelj, V. (2007) WoS2Pajek. Networks from Web of Science. Version 1.5 (2017). http://vladowiki.fmf.uni-lj.si/doku.php?id=pajek:wos2pajek Batagelj, V., Cerinsek, M. (2013). On bibliographic networks. Scientometrics 96 (3), 845-864. Batagelj, V., Doreian P., V., Ferligoj, A., Kejzar N. (2014). Understanding Large Temporal Networks and Spatial Networks: Exploration, Pattern Searching, Visualization and Network Evolution. Carley K.M. (2003). Dynamic Network Analysis. in the Summary of the NRC workshop on So- cial Network Modeling and Analysis, Ron Breiger and Kathleen M. Carley (Eds.), National Research Council, p. 133 -- 145. Cerinsek, M., Batagelj, V. (2017). Semirings and Matrix Analysis of Networks. Encyclopedia of Social Network Analysis and Mining. Reda Alhajj, Jon Rokne (Eds.), Springer, New York. Cerinsek, M., Batagelj, V. (2015). Network analysis of Zentralblatt MATH data. Scientometrics, 102 (1), 977-1001. Clarivate Analytics (2018). https://clarivate.com/products/web-of-science/databases/ 12 De Nooy, W., Mrvar, A., Batagelj, V. (2018). Exploratory Social Network Analysis with Pa- jek; Revised and Expanded Edition for Updated Software. Structural Analysis in the Social Sciences, CUP. Diesner, J., Carley, K.M. (2004). Revealing Social Structure from Texts: Meta-Matrix Text Analysis as a Novel Method for Network Text Analysis. Chapter 4 in Causal Mapping for Research in Information Technology, V.K. Narayanan and Deborah J. Armstrong, eds. Idea Group Inc., 2005, p. 81-108. Gauffriau, M. (2017). A categorization of arguments for counting methods for publication and citation indicators. Journal of Informetrics, 11(3), 672-684. Kessler, M. (1963). Bibliographic coupling between scientific papers. American Documenta- tion, 14(1): 10 -- 25. Krackhardt, D., Carley, K.M. (1998). A PCANS Model of Structure in Organization. In Pro- ceedings of the 1998 International Symposium on Command and Control Research and Tech- nology Evidence Based Research: 113-119, Vienna, VA. Leydesdorff, L., Park, H.W. (2016). Full and Fractional Counting in Bibliometric Networks. Journal of Informetrics Volume 11, Issue 1, February 2017, Pages 117 -- 120. Lindsey, D. (1980). Production and Citation Measures in the Sociology of Science: The Prob- lem of Multiple Authorship. Social Studies of Science, 10(2), 145 -- 162. Marshakova, I. (1973). System of documentation connections based on references (sci). Nauchno-Tekhnicheskaya Informatsiya Seriya, 2(6): 3 -- 8. Newman, M.E.J. (2001). Scientific collaboration networks. II. Shortest paths, weighted net- works, and centrality. Physical Review E, 64(1), 016132. Newman, M.E.J. (2004). Coauthorship networks and patterns of scientific collaboration. Pro- ceedings of the National Academy of Sciences of the United States of America 101(Suppl1), 5200 -- 5205. Perianes-Rodriguez, A., Waltman, L., Van Eck, N.J. (2016). Constructing bibliometric net- works: A comparison between full and fractional counting. Journal of Informetrics, 10(4), 1178-1195. Prathap, G., Mukherjee, S. (2016). A conservation rule for constructing bibliometric network matrices. arXiv 1611.08592 Small, H. (1973). Co-citation in the scientific literature: A new measure of the relationship between two documents. Journal of the American Society for Information Science, 24(4): 265 -- 269. 13
1211.4627
2
1211
2015-04-28T13:25:28
Enabling Social Applications via Decentralized Social Data Management
[ "cs.SI", "cs.CY", "cs.DC", "physics.soc-ph" ]
An unprecedented information wealth produced by online social networks, further augmented by location/collocation data, is currently fragmented across different proprietary services. Combined, it can accurately represent the social world and enable novel socially-aware applications. We present Prometheus, a socially-aware peer-to-peer service that collects social information from multiple sources into a multigraph managed in a decentralized fashion on user-contributed nodes, and exposes it through an interface implementing non-trivial social inferences while complying with user-defined access policies. Simulations and experiments on PlanetLab with emulated application workloads show the system exhibits good end-to-end response time, low communication overhead and resilience to malicious attacks.
cs.SI
cs
A Enabling Social Applications via Decentralized Social Data Management NICOLAS KOURTELLIS, Yahoo Labs, Barcelona, Spain JEREMY BLACKBURN, Department of Computer Science and Engineering, University of South Florida CRISTIAN BORCEA, Department of Computer Science, New Jersey Institute of Technology ADRIANA IAMNITCHI, Department of Computer Science and Engineering, University of South Florida An unprecedented information wealth produced by online social networks, further augmented by location/collocation data, is currently fragmented across different proprietary services. Combined, it can accurately represent the social world and enable novel socially-aware applications. We present Prometheus, a socially-aware peer-to-peer service that collects social information from multiple sources into a multigraph managed in a decentralized fashion on user-contributed nodes, and exposes it through an interface implementing non-trivial social inferences while complying with user-defined access policies. Simulations and experiments on PlanetLab with emulated application workloads show the system exhibits good end-to-end response time, low communication overhead and resilience to malicious attacks. Additional Key Words and Phrases: socially-aware data management, decentralized social graph, P2P networks, social sen- sors, social inferences ACM Reference Format: Nicolas Kourtellis, Jeremy Blackburn, Cristian Borcea and Adriana Iamnitchi, 2015. Enabling Social Applications via De- centralized Social Data Management. Special Issue on Foundations of Social Computing ACM Trans. Internet Technol. V, N, Article A (January YYYY), 27 pages. DOI:http://dx.doi.org/10.1145/0000000.0000000 1. INTRODUCTION Recent socially-aware applications leverage users' social information to provide features such as filtering restaurant recommendations based on reviews by friends (e.g., Yelp), recommending email recipients or filtering spam based on previous email activity [Kong et al. 2006], and exploiting social incentives for computer resource sharing [Li and Dabek 2006; Nguyen et al. 2008]. Social informa- tion is also leveraged in conjunction with location and collocation data in mobile applications such as Loopt and Foursquare, which collect, store, and use sensitive geosocial information. The state of the art is to collect and manage such information within an application, thus offering social functionalities limited only to the context of the application, as in the examples above, or to expose this information from platforms that specifically collect and manage it, such as online social networks (OSNs). For example, Facebook1 and OpenSocial2 allow 3rd-party application developers and websites to access the social information and activity of millions of users. However, hidden in- centives for users to have many OSN "friends" lead to declarations of contacts with little connection in terms of trust, common interests, shared objectives, or other such manifestations of real social re- lationships [Golder et al. 2007]. Thus, an application that tries to provide targeted functionalities using social information exposed by current OSNs must wade through a lot of noise. This paper presents Prometheus, a peer-to-peer (P2P) service that collects social information from multiple sources and enables a wide range of new socially-aware applications to mine it via an API that implements social inferences. This service collects information from actual interactions between users within multiple environments and under multiple identities (e.g., OSNs, email, mobile phones). Thus, it maintains richer and more nuanced social information than current OSNs or social applications, which can lead to more accurate inferences of trust, interests, and context. Prometheus represents social information as a directed, weighted and labeled multi-graph distributed on a P2P platform. Access to such aggregated information is controlled by user-defined policies. 1http://developers.facebook.com/docs/reference/api 2http://opensocial.org/ ACM Transactions on Internet Technology, Vol. V, No. N, Article A, Publication date: January YYYY. A:2 N. Kourtellis et al. The choice of a P2P architecture was motivated by two factors: user privacy and service availabil- ity. Two alternatives could be considered: a centralized service, and a decentralized service running on mobile phones. Companies such as Google and Facebook already perform centralized aggre- gation of user data from independent services. However, they have no incentives or appropriate business models to allow users full control over their data. Additionally, some OSNs institute par- ticularly draconian policies concerning the ownership of user-contributed information and content. For example, users cannot delete their data from the Facebook servers and they cannot easily export their data to a competitive service. Furthermore, users must trust their OSN provider for complying with privacy policies related to sharing data with 3rd parties. However, the recent scandal of NSA's unauthorized snooping of millions of users' data from such companies [Gellman and Poitras 2013; TheGuardian 2014] is yet another proof of Big Brother monitoring. In contrast, a decentralized service that gives users full control of how their private information is aggregated and accessed is desirable. An alternative architecture is to store social information in a fully decentralized manner on users' mobile devices, as proposed in [Mokhtar et al. 2009; Pietilainen et al. 2009; Sarigol et al. 2010; Toninelli et al. 2011]. In this architecture, a mobile device stores its user's egonet: all the relevant social encounters of its user with others. However, research [Benevenuto et al. 2009; Jiang et al. 2010] found that 30 to 70% of requests in OSNs, such as for viewing profiles or sending messages, came not from direct social contacts, but from neighbors at least 2 hops away in the social graph. Such requests could not be satisfied solely from the information stored in egonets. Thus, more infrastructure would be needed to allow gathering of data from other mobile devices, therefore, including issues related to access, online presence, and limited resources (especially battery). These aspects led us to opt for an in-between architecture for Prometheus, fully decentralized but capable to aggregate groups of egonets on the same peer and with higher availability. An overview of the Prometheus service is presented in Section 2, and related work is covered in Section 3. Sec- tion 4 presents a detailed design of the service. We evaluated Prometheus over large-scale graph simulations and with a large-scale deployment of a prototype on PlanetLab and tested its perfor- mance with high-stress workloads from emulated applications. The results in Section 5 show that the response time and system overhead for social inference execution is reduced when user social data are distributed onto peers using a geo-socially-aware approach. We also implemented CallCen- sor, a mobile social application that uses Prometheus to decide whether to filter out incoming calls based on the current social context. As shown in Section 6, the response time for this application running on a Google Android phone meets real-time deadlines, demonstrating that Prometheus' overhead is practical for real applications. In addition, in Section 7 we study the system's resilience to malicious attacks and demonstrate that its socially-informed design and social graph structure make the system more resilient to graph and inference request attacks. We conclude in Section 8. 2. OVERVIEW In order to better understand the functionality of the Prometheus service, we present it as part of the social hourglass infrastructure [Iamnitchi et al. 2012; Kourtellis 2012]. This infrastructure (illus- trated in Figure 1(a)) consists of five main components: (1) social signals, (2) social sensors, (3) per- sonal aggregators, (4) a social knowledge service (SKS), and (5) social applications. Social signals are unprocessed user social information such as interaction logs (e.g., phone call history, emails, etc.) or location and collocation information. Social sensors run on behalf of a user and parse the user's social signals, analyze them, and send processed social information to the personal aggregator of the user. The user's personal aggregator combines social information from the user's sensors and produces a personalized output based on user preferences. This personalized social information is sent for storage and management to the SKS which maintains an augmented social graph that can be mined by applications and services through an API that implements social inferences. Prometheus fulfills the role of the SKS in the social hourglass infrastructure. ACM Transactions on Internet Technology, Vol. V, No. N, Article A, Publication date: January YYYY. Enabling Social Applications via Decentralized Social Data Management A:3 (a) Prometheus in the Social Hourglass Infrastructure (b) Overview of Prometheus Architecture Fig. 1: (a) Prometheus in the social hourglass infrastructure. (b) Prometheus peers are organized using Pastry, a DHT-based overlay, Scribe, a DHT multicast infrastructure, and Past, a DHT storage system. Scribe and Pastry are used for social graph and group maintenance. Users can trust selected machines, allowed to decrypt and mine the user's social subgraph to fulfill requests. Personal ag- gregators store social input on Past and trusted peers retrieve and represent it as a directed, labeled, weighted multi-graph. Applications mine the graph via Prometheus API social inferences, executed between peers through direct P2P communication. 2.1. Input from Social Sensors & Aggregators We refer to social signals as the information that exposes social interactions between people. Di- verse social signals already exist as byproducts of Internet- or phone-mediated interactions, such as email logs, comments on blogs or OSNs, instant messaging, ratings on user-generated content, phone call logs, or via face-to-face interactions determined from (GPS or Bluetooth-reported) col- location data. For example, a social signal could reflect the interactions of two users over a soccer video posted on YouTube. These interactions reflect comments, "likes", other video sharing, etc. Social sensors analyze users' social signals. Sensors are applications running on behalf of a user on various platforms such as their mobile phone, PC, web browser, or trusted 3rd party services. They transform the domain-specific interactions between their user-owner (ego) and others (alter) into a message with the format: ego :<alter, label, weight>, where label specifies the interaction domain (e.g., F acebook, Gaming, etc.) and weight associates a numeric value (e.g., in range [0, 1]) to the interaction's intensity, as in [Xiang et al. 2010]. Many such sensors already exist, although they may not output social ties as they have been implemented in different contexts and for different purposes. For example, such sensors record and quantify OSNs' user activity [Lewis et al. 2008], co-appearance on web pages [Matsuo et al. 2006], or co-presence recorded as collocation via Bluetooth [Eagle and Pentland 2006]. The personal aggregator is a trusted application typically running on a user-owned device (e.g., mobile phone) responsible for fusing and personalizing the information from the user's social sig- nals. It can perform sophisticated analysis on the input from the sensors, for example, to differ- entiate between routine encounters with familiar strangers and interactions between friends [Eagle and Pentland 2006]. It also applies user preferences for weighing signals differently: for example, a Google Talk social signal may weigh less than Skype Chat in the aggregated value. In effect, the ag- gregator transforms both the labels and weights received from sensors into a quantitative representa- tion of ego and alter's social interactions. Finally, it sends to the SKS a tuple for an aggregated inter- action between ego and an alter, in the format: <ego, alter, general label, aggregated weight>. ACM Transactions on Internet Technology, Vol. V, No. N, Article A, Publication date: January YYYY. A1A2A3S11S21S22S33S32S43Social signals encode social dataSocial sensors analyze social signals and quantify social relationsPersonal aggregators collect, fuse, and personalize sensor outputPrometheus stores social data into a distributed social graphNovel applications access social data through a Prometheus API to provide socially-aware functionalitiesCallCensorSofaSurferRoommate FinderNETFLIXfacebookBluetoothSocial SignalsSocially-aware ApplicationsGoogleYouTuberedditValveLinkedInciteulikeSteam,0.3Facebook,0.15Steam,0.3Steam,0.2GChat,0.3Facebook,0.1dbacPROMETHEUS>GRAPHLinkedIn,0.1Skype,0.2Facebook,0.1LinkedIn,0.1Scribe'/'Past'Pastry'/'DHT'Access'Control'Policy'and'Key'Management'Trusted'Peer'Group'Management'Socially>aware'Applica@ons'Who$can$be$my$next$online$game$partner?$Trusted'Peer'Lists'(TPL)''Social'Graph'Management'/'API'$$$$2+$hop$data$request$Update$TPL$Pull$new$social$data$<c,d,Steam,0.05>$$Personal'Aggregators'$$Netflix,0.3YouTube,0.15YouTube,0.3Google+,0.3YouTube,0.3Facebook,0.1Skype,0.25Netflix,0.3Netflix,0.2dfebacPROMETHEUS GRAPHSOCIALLY-AWARE APPLICATIONSFacebook,0.3<a, b, LinkedIn, 0.05>Top YouTube relation of c?{ d }Is the incoming callpersonal or work related?Who should I inviteto the pop concert?LinkedIn,0.1Skype,0.2LinkedIn,0.3Pastry/DHTTrusted Peer Group ManagementPrivacy ManagementSocial Graph ManagementScribePastPERSONAL AGGREGATORSPROMETHEUS PEER ARCHITECTURE(a)(b)YouTube,0.01Push$new$social$data$Top$5$game$relaFons$of$user$c?$Remote$Data$Request$Direct'Peer'Communica@on''Find$appropriate$trusted$peers$Prometheus$Peer$Components$Comms$ A:4 N. Kourtellis et al. 2.2. Prometheus as a Social Knowledge Service The SKS provides a mechanism for storing and managing user social data and exposing them to ap- plications and services. Prometheus, which fills-in the role of SKS in the social hourglass infrastruc- ture, distributes the social information received from the aggregators on multiple user-contributed peers for better service and data availability, while protecting access to data via encryption and user-specified access policies. Prometheus design supports the following functionalities. Persistent service for mining the social graph is achieved by employing a p2p architecture on user-contributed resources without the availability constraints of architectures based on mobile phones. In particular, our objective is to allow applications access to distant nodes in the social graph, such as friends-of-friends queries. Support to an unrestricted set of social applications and services is provided via two mechanisms: an API that exports social inferences (such as social strength between indirectly-connected users) and aggregated social information represented by social edge labels and weights. For the latter, Prometheus maintains a weighted, directed, labeled, and multi-edged social graph, where vertices correspond to users and labeled edges correspond to interactions between users, as reported by their aggregators (see Figure 1(b) for an example of such a graph). Edge labels specify the type, and weights specify the intensity of interaction. Edge directionality reflects the asymmetry of users' perception of a social relationship [Wellman 1988] and allows for potentially conflicting reports from the interacting users' aggregators. User-controlled data access is guaranteed via two mechanisms. First, data owners can specify access control policies to limit access to their information. Second, all data are encrypted; however, for mining the social graph information, some peers need to decrypt data in order to process it. Thus, each user selects a group of trusted peers; only these peers can decrypt the user's social data. In addition, Prometheus deals with the typical challenges of churn-prone p2p systems by leverag- ing well-established, previously proposed solutions in distributed hashtable overlays (DHTs). Fig- ure 1(b) presents an overview of the architecture. Each peer runs three software components: 1) for social graph management and application request execution; 2) for access control policy and key management; and 3) for trusted peer group management. 2.3. Output to Applications and Services Prometheus exposes an interface to a rich set of social inference requests computed over the dis- tributed social graph. For example, an application can request on its user's behalf to receive the top n relations with whom the user interacts over Facebook. Similarly, it can request the social strength between a user and another user not directly connected in the social graph. Prometheus provides the mechanism with which inference requests can access not only a single user's social neighborhood (i.e., directly connected users), but also the social data of users located several hops away in the global social graph. As mentioned before, all inferences are subject to user-defined access control policies enforced by the trusted peers of the data owner. 2.4. Prometheus in Use: GamePartnerFinder Application An application scenario is presented below for explaining how Prometheus is used in the context of the social hourglass infrastructure. Let us assume that Tom is an active online gamer. However, due to his type of work, he frequently travels around the world and his change of location does not allow him to easily find game partners to play online: he is always on different timezone with respect to his home buddies and also network delays can greatly hinder his gaming experience. To solve this issue, he developed the GameP artnerF inder, an application which utilizes his geo-social information stored on Prometheus to find for him partners to play with while on travel. The application takes into account information such as: (1) his friends on Steam Community (SC) he frequently plays with, (2) his friends on Facebook (F B) he interacts with, (3) his frequent phone / Google Chat / Skype contacts with respect to IM and calls, (4) his professional contacts on LinkedIn, (5) his current location and friends he is collocated with (at a city / country / continent level). ACM Transactions on Internet Technology, Vol. V, No. N, Article A, Publication date: January YYYY. Enabling Social Applications via Decentralized Social Data Management A:5 At installation, the application checks with Tom's aggregator which of the required and optional social sensors he is currently registered with. These sensors report Tom's activity to Prometheus, subject to a personalized filter stored and applied by his aggregator (as mentioned earlier). This filter is updated rarely -- when there are significant changes in activity patterns or new social sensors are deployed -- or can be left to a default setting that weighs all signals equally. GameP artnerF inder will mine Prometheus' aggregated information on Tom in order to decide which contacts to present as possible game partners for his next session at his current location. To compile this list, GameP artnerF inder will first query Prometheus for a list of Tom's so- cial contacts that are also geographically close to him. This allows the application to infer which contacts would be good candidates with respect to network delays and timezone (e.g. same geo- graphical region). Further, the application will query Prometheus for the type of connection and social distance between each returned contact and Tom. Contacts classified as "friends of friends" (i.e., 2-hop neighbors) could be included in the list, depending on user-specified application-related preferences. For instance, Tom could specify that 1-hop SC or F B friends can be included, as well as 2-hop SC friends connected over high activity weights, but not 2-hop F B friends who are not already in the previous categories. LinkedIn contacts could be filtered out. The multi-hop request allows the application to infer a diverse list of online contacts, close to Tom with respect to network delays, with similar game expertise, and have the social incentives to accept a game invitation from Tom. Non time-critical applications such as the GameP artnerF inder could wait for some time (e.g., minutes) before producing a good list of game partner candidates, especially if this search involves multi-hop inferences and network delay measurements. However, more time-critical ap- plications such as a context-aware phone-call filtering application (e.g., the CallCensor [Kourtellis et al. 2010b,a] and Section 6) could have a lower tolerance on waiting time. To facilitate both types of applications, we extended the Prometheus API from past work to support not only the above geo-social requests, but also allow applications to define a timeout parameter which limits the ap- plication waiting time. Thus, if Bob installed CallCensor, his incoming personal calls could be automatically silenced during professional meetings, but co-workers' or other professional-related calls could be let through, and this filtering decision should be made within a very short time period (e.g., a few seconds) before the call is dropped or goes to voicemail. 3. RELATED WORK Decentralized management of social data using peer-to-peer architecture has been proposed in other studies such as PeerSoN [Buchegger et al. 2009], Vis-`a-Vis [Shakimov et al. 2009], Safebook [Cu- tillo et al. 2010], LifeSocial.KOM [Graffi et al. 2011] and LotusNet [Aiello and G.Ruffo 2012]. PeerSoN [Buchegger et al. 2009] is a two-tier system architecture: the first tier is used to lookup (through a DHT) for metadata of users, current location/IP, notifications, etc.; the second tier allows opportunistic and delay-tolerant networking and is used for the actual contact between peers and users and the exchange of data (files, profiles, chat, etc.). Users can exchange data either through a DHT storage or directly between their devices. Vis-`a-Vis [Shakimov et al. 2009] introduces the concept of a Virtual Individual Server (VIS) where each user's data are stored on a personal virtual machine. While similar to the trusted peer concept in Prometheus, VISs are hosted by a centralized cloud computing provider to tackle peer churn, whereas Prometheus provides a truly decentralized, free of cost infrastructure and uses social incentives to reduce churn of user-contributed peers. Safebook [Cutillo et al. 2010] is a decentralized OSN with a 3-component architecture: a trusted identification service to provide each peer and user unambiguous identifiers, a P2P substrate for lookup of data, and "matryoshkas", concentric rings of peers around each member's peer that pro- vide trusted data storage, profile data retrieval and obscure communication through indirection. Similarly, Prometheus users employ multiple trusted peers and forwards messages between peers based on social relations and inference requests, while restricting a large scale view of the graph through P2P decentralization. Prometheus differs, however, in the exposure of the graph as a first class data object through inference functionality. ACM Transactions on Internet Technology, Vol. V, No. N, Article A, Publication date: January YYYY. A:6 N. Kourtellis et al. LotusNet [Aiello and G.Ruffo 2012] is a DHT-based OSN that binds user identities with their overlay nodes and published resources for increased security. Users control access to their data by issuing signed grants to other users applied during retrieval of data. Services such as event no- tification, folksonomic content search and reputation management are demonstrated. In LifeSo- cial.KOM [Graffi et al. 2011], user information is stored in the form of distributed linked lists in a DHT and is accessible from various plugin-based applications, while enforcing symmetric PKI to ensure user-controlled privacy and access. User data are isolated from one another, and peers access them individually. Commercial efforts such as Enthinnai,3 FreedomBox,4 and Diaspora5 implement distributed social networking services allowing users to share content in a decentralized fashion. Our work differs from the previously noted academic and commercial approaches in the follow- ing ways. First, it not only collects and stores user social information from multiple sources in a P2P network, but also exposes social inference functions to socially-aware applications that mine the so- cial information stored. Second, it addresses the space between centralized and fully decentralized systems, as it allows multiple users to store social information on common peers they trust. These peers can locally mine the collection of social data entrusted to them by the groups of (possibly socially-connected) users, thus improving social data access and quality of inferences to applica- tions. Third, Prometheus enables users to select trusted peers independent from the users' (mobile) devices to decrypt and mine their social data at any time, thus increasing service availability. 4. DESIGN Prometheus manages a labeled, weighted social multigraph distributed on a collection of user- contributed peers. Unlike other p2p solutions, Prometheus does not require each user to contribute a peer. Instead, it leverages social incentives to allow a user's data be managed by the peer contributed by a trusted social relation. This approach embeds social awareness in the service design and has three immediate benefits. First, it improves scalability since the system size can be much smaller than the number of its users. Second, socially-incentivized users keep their computers online, thus reducing churn [Li and Dabek 2006; Nguyen et al. 2008] and consequently increasing service avail- ability. And finally, because socially-related users are likely to select the same trusted peers for their data management, the resulting data collocation decreases remote access for social graph traversals. A less intuitive benefit from the social-based mapping of the social graph onto the p2p network in- cludes a reduced vulnerability to malicious attacks in comparison to random-based mappings such as pure DHT-based systems, as demonstrated in Section 7. Prometheus uses a public-key infrastructure (PKI) to ensure both message confidentiality and user / peer authentication. Using their personal trusted device (e.g., mobile phone or laptop), users create public and private keys for both themselves (P , p) and their trusted peer group (G, g) decrypting their social data. The group public key (G) can be placed on the DHT for other peers to access for decryption of incoming messages. Peers trusted by a user must have his group keys as well as his personal public key (P ). All messages contain nonces added by the senders. They are reattached in the replies by the receivers to acknowledge correct delivery and execution, and in combination with timestamps, they dissallow replay attacks. After these appendices, the messages are digitally signed with the sender's private key to preserve integrity and confirm authenticity, and then encrypted with the receiver's public key to protect the message from unauthorized receivers. The Prometheus social data consist of labeled and weighted social edges as reported by personal aggregators. They are signed, encrypted and stored in Past [Rowstron and Druschel 2001b], a DHT-based storage built on top of the Pastry overlay [Rowstron and Druschel 2001a]. Only trusted peers are capable of decrypting their user's data for graph processing. 3http://www.enthinnai.com/ 4http://freedomboxfoundation.org/ 5https://joindiaspora.com/ ACM Transactions on Internet Technology, Vol. V, No. N, Article A, Publication date: January YYYY. Enabling Social Applications via Decentralized Social Data Management A:7 4.1. User Registration A user registers with Prometheus by creating a uniform random U ID from the circular 128-bit ID space of the DHT (typically the hash of their public key). At registration time, the user specifies her peer(s) contributed to the network (if any). The user then creates a mapping between her U ID and the list of these peers' IP addresses, signs it with her private key and stores this mapping in the DHT network as the key-value pair U ID = {IP1, ..., IPn}. When one of these peers returns from an offline state, it updates the mapping with its current IP address. The user also compiles a list of other Prometheus users with whom she shares strong out-of-band trust relations (and has ex- changed public keys) and retrieves from Past their machine mappings. She confirms the mappings' authenticity and from the returned list of peers, she selects an initial set as her trusted peer group. The larger this set, the higher the service availability; at the same time, the consistency and overall performance may decrease. The trusted peer group may change over time, as shown next. 4.2. Trusted Peer Group Management The main issues concerning the trusted peer group management are group membership and search for trusted peers. For managing the trusted peer group we leverage Scribe [Castro et al. 2002], a group communication solution designed for DHTs. In general, communication between trusted peers for group management happens over the DHT/Scribe's multicast protocol by appending the message to be sent with the groupid, signing with the group private key and encrypting with the group public key: {{msg, nonce, groupid, timestamp}g}G. The receiving trusted peers decrypt the message with the group private key, verify the signature of the sender peer as trusted using the group public key and read/execute the message. The group management happens as follows. Let us consider that Alice uses her personal device as a proxy to add peers to her trusted peer group, initialized as a Scribe group with the handle "Trusted Peer Group UID", where UID is Alice's user id. For this, she initiates a secure three-step handshake procedure to establish a two-way trust relationship between her and Bob, a peer owner. The following steps take place in the direct peer communication layer (Figure 1(b)): (1) Through out-of-band methods, she has invited Bob and he has accepted to participate in her trusted peer group by sharing his public key (as mentioned earlier). (2) Alice sends Bob the keys of her trusted peer group (enhanced with a nonce, timestamp, Bob's userid, and then signed with her private key and encrypted with Bob's public key). (3) By decrypting the message with his private key and verifying its authenticity with Alice's public key, Bob installs on his peer the received group keys, enabling his peer to join Alice's group by sending a digitally signed and encrypted subscribe request to Alice's Scribe trusted group:{{subscribe, nonce, groupid, timestamp}g}G. Receiving these keys allows the newly trusted peer to access the user's social data as explained later. Note that a malicious peer owner cannot force anyone to give him their data if they don't trust him first. For removing a trusted peer, Alice will have to create new group keys, re-encrypt her signed data with the new group public key, and store them in the DHT. The removal of the peer from a user's trusted group is multicasted to all group peers and the peer is unsubscribed from the group. The new group keys are distributed to the still trusted peers as before. The distribution of new keys and re-encryption of the social data disallows the removed peer from decrypting updated versions of the user's data. If a peer owner decides to remove her peer from another user's trusted group (e.g, due to overload), the removal request is multicasted to the group, which in turn executes the above procedure and alerts the data owner of the change. A requesting peer or application can find a user's trusted peers by submitting a multicast TPL request with handle Trusted Peer Group UID. With the multicast, all online group trusted peers re- spond with their IP and signed membership, which is verified for authenticity with the user's group public key. The requesting peer creates a trusted peer list (TPL) of IPs based on peer responses. The multicast allows the requesting peer to have peer alternatives in case of churn or erroneous com- munication with the first responding peer. The search for trusted peers follows the Scribe multicast ACM Transactions on Internet Technology, Vol. V, No. N, Article A, Publication date: January YYYY. A:8 N. Kourtellis et al. Fig. 2: An example of a social graph for eight users (a-h) distributed on seven peers. The left figure shows the mapping between users, peer owners, and trusted peers (upper left corner) and how users are connected with each other over social edges, each marked with its label and weight. The right figures illustrate the subgraphs maintained by peers 1 and 5. Users in dark color (e.g., a, b, c on peer 1) trust the peer to manage their social data. Users in light-shaded color (e.g., e, d on peer 1) do not trust the peer but are socially connected with users who do. tree which utilizes the Pastry DHT routing and its network proximity metric to forward messages to near-by peers, thus reducing overall delays. In effect, the responds from trusted peers are sorted in the TPL by overall latency. The peer, upon creating the TPL for a user's group, can communicate directly with the individual trusted peers, preferably the one responding fastest. Prometheus caches the TPL after the first access and updates it when the trusted peers are unresponsive, changed their IP, or became untrusted. Users can also apply their own TPL update policies based on their usage patterns. A user's social data are unavailable if all her trusted peers leave the network; no service requests involving this user can be answered until a trusted peer rejoins the network. However, we ensure durability of users' generated data (i.e., input from social aggregators) via encrypted storage and replication in the DHT by Past. 4.3. Distributed Social Graph Prometheus represents the social graph as a directed, labeled, and weighted multi-edged graph [An- derson et al. 2010], maintained and used in a decentralized fashion as presented in Figure 2. Multiple edges can connect two users, and each edge is labeled with a type of social interaction and assigned a weight (a real number in the range [0, 1]) representing the interaction's intensity. The labels for interactions and their associated weights are assigned by the personal aggregator of each user. From an application point of view, distinguishing between different types of interactions allows for better functionality. For extensibility, we designed Prometheus to be oblivious to the number and types of social activities reported by the aggregators. Furthermore, we chose to represent the graph as directed and weighted because social ties are asymmetrically reciprocal [Wellman 1988]. This representation also limits illegitimate graph uses (e.g., for spamming). A user's latest known location and an associated timestamp are maintained as an attribute of the user's vertex in the graph. Social data (sd) of a user are appended with a nonce, his group's id and a timestamp, then signed with the user's private key and then encrypted with the user's group public key: {{sd, nonce, groupid, timestamp}p}G. This encrypted item is stored in Past in the append-only ACM Transactions on Internet Technology, Vol. V, No. N, Article A, Publication date: January YYYY. UserOwned Trusted IDPeers Peers a - - - - 1,2 b 1 1,2 c 2 1,2,3 d 3 2,3,4,5,6 e 4 3,4 f 5,6 3,5,6 g - - - - 4 h 7 5,6,7acfegbdhYouTube,0.1YouTube,0.15YouTube,0.25LinkedIn,0.3Skype,0.1Facebook,0.2YouTube,0.1Facebook,0.25LinkedIn,0.3YouTube,0.3Facebook,0.3Skype,0.2Facebook,0.3YouTube,0.25Skype,0.3Facebook,0.3YouTube,0.1LinkedIn,0.25Facebook,0.35Skype,0.4YouTube,0.35Skype,0.2Peer 1acebdYouTube,0.15YouTube,0.25LinkedIn,0.3Skype,0.1Facebook,0.2YouTube,0.1Facebook,0.25LinkedIn,0.3YouTube,0.3Facebook,0.2Facebook,0.3Skype,0.2Peer 5cfegbdhYouTube,0.1Facebook,0.25LinkedIn,0.3YouTube,0.3Facebook,0.1Facebook,0.3YouTube,0.25Skype,0.3Facebook,0.3YouTube,0.1LinkedIn,0.25Facebook,0.35Skype,0.2Facebook,0.2Facebook,0.1 Enabling Social Applications via Decentralized Social Data Management A:9 file Social Data U ID. Only the user's personal aggregator can send updates to create new edges, remove edges, or modify edge weights. These updates are appended in this file as records with a sequence number. Trusted peers periodically check the file for new records and retrieve all such records: this is easily done based on sequence number comparison starting from the end of the file. They decrypt new records with the user's group private key (g) and verify the data's authenticity with the user's personal public key (P). By checking the nonce, they confirm they haven't received this item before and incorporate the changes with the rest of the local graph. As the social data file is append-only, the trusted peers can access it at any time: in the worst case, they will miss the latest update. Therefore, for short periods of time, the trusted peers may have inconsistent data, but this is not a major problem as social graphs do not change often [Golbeck 2007]. Edges may "decay" over time if few (or no) activity updates are received [Roberts and Dunbar 2010]. This aging process should be activity specific, but it should also reflect the user's social habits and interests: users who are less socially active and users with a great number of friends should have their relationships age slower. Currently, the system applies a simple aging function to reduce an edge's weight by 10% for every week the two users do not interact over the particular label (thus, the connection never completely disappears and the aging happens slowly). A user's aggregator may specify a different decrement value of the weight and the time period for aging (these values are also stored in the Social Data U ID file for each user). 4.4. Social Inference API Prometheus exposes to applications an API of social inference functions that are executed in a decentralized fashion; more complex inferences can be built on top of this set. Relation Test(ego, alter, α, χ) is a boolean function that checks whether ego is directly con- nected to alter by an edge with label α and with a minimum weight χ. The CallCensor appli- cation [Kourtellis et al. 2010b,a] can use this function to determine if an incoming call is from a coworker with a strong social tie, and therefore, should be let through even on weekends. Top Relations(ego, α, n) returns the top n users directly connected to ego by an edge with label α, and ordered by decreasing weights. An application can use this function, for example, to invite users highly connected with ego to share content related to activity α. Our previous study [Kourtellis et al. 2010b] revealed volatility of the peer-to-peer communication and long response delays during multi-hop inference execution. Thus, we redesigned the following API functions to offer better quality of service to applications, by allowing them to define a timeout parameter T , which limits the application waiting time. Neighborhood(ego, α, χ, radius, T) returns the set of users in ego's social neighborhood who are connected through social ties of label α and minimum weight χ within a number of social hops equal to radius. The radius parameter allows for a multi-hop search in the social graph (e.g., setting radius to 2 will find ego's friends of friends). The GamePartnerFinder application can use this function to determine if a user is in ego's "gaming" graph neighborhood even if not directly connected. Proximity(ego, α, χ, radius, distance, timestamp, T) is an extension of the neighborhood function which filters its results based on physical distance to ego. After ego's location information is col- lected, and neighborhood returns a set of users, proximity returns the set of users within distance from ego and their location information is at most as old as timestamp. Users who do not share their location or have location information older than the timestamp are not returned. A mobile phone application like CallCensor might use this function to infer the collocated coworkers within distance from ego. Social Strength(ego, alter, T) returns a real number in the range [0, 1] that quantifies the social strength between ego and alter from ego's perspective. Past studies in sociology [Friedkin 1983] observed that two individuals have meaningful social relationships when connected within two so- cial hops (i.e., "horizon of observability"), and their relationship strength greatly depends on the number of different direct or indirect paths connecting them. Therefore, the two users in this func- tion can be directly or indirectly connected and through multiple parallel paths (e.g., paths c→b→e ACM Transactions on Internet Technology, Vol. V, No. N, Article A, Publication date: January YYYY. A:10 N. Kourtellis et al. and c→d→e between c and e, Figure 2). The returned value is normalized, as explained below, to ego's social ties, to ensure that the social strength is less sensitive to a particular user activity. Assume Λi,j is the set of labels of edges for two directly connected users i and j, w(i, j, λ) is the weight of an edge between i and j over label λ, and Θi the set of directly connected neighbors to i. Then, nw(i, j) (eq.1) is the overall normalized weight between i and j. Also, assume users i and m are indirectly connected over different 2-hop paths. Then, S(i, m) (eq.2) is the value returned for social strength between i and m, over a multi-level 2-hop path. This function could be used, for example, to assess social incentives for resource or data sharing. (cid:88) (cid:16) (cid:88) ∀λ∈Λi,j w(i, j, λ) (cid:17) (1), nw(i, j) = max ∀j∈Θi ∀λ∈Λi,j w(i, j, λ) S(i, m) = 1 − (cid:89) (cid:18) ∀j∈Θi∩Θm 1 − min{nw(i, j), nw(j, m)} (2) 2 (cid:19) Inference Function Execution: Assume user x wants to submit (through an application) a so- cial inference request to one of her trusted peers. Using the process explained in Section 4.2, the application creates x's TPL and forwards the request to x's fastest responding and thus network-closest (shortest latency) trusted peer. This is done through the direct communication layer in a secure fashion by appending on the request a nonce, x's userid and a timestamp, then signing the message with x's private key and encrypting it with x's group public key: {{request, userid, nonce, timestamp}p}G. The receiving peer decrypts the message with x's group private key (g), verifies the submitter's identity via her public key and if the query has not been seen before (by checking the nonce) and the peer is indeed trusted by x, the peer enforces x's access control policies (described next). In all other cases, the request is dropped. Then the peer fulfills the request by (1) traversing the local social subgraph for the requested information, (2) signing and encrypting the result using the requesting user's public key and the group's private key, respectively, and (3) returning it to the user (application). For functions that can traverse the graph for n hops (i.e., Neighborhood, Proximity and So- cial Strength), the peer submits signed and encrypted secondary requests for information about other users to their trusted peers, as follows. A secondary request includes the U ID of the original submitter in order to verify her access rights, then it is signed with her group private key and en- crypted with the receiving user group's public key. A time period of T ∗ (n − 1) seconds is given to the secondary peers to respond with their results (peers at each hop use independent clocks for T seconds). Each receiving secondary peer decrypts the request with the group private key, authen- ticates the signature with the requesting group's public key and checks the access control policies for the requesting user. If the request is granted, the result is returned to the requesting peer. If the request still needs more information, that peer (e.g., at hop k) repeats the same process and submits a secondary request with an adjusted T ∗ (n − k − 1) timeout. Finally, the original requesting peer recursively collects all the replies and submits the final result to the application. 4.5. Access Control Policies Users can specify access control policies (ACPs) upon registration and update them any time there- after. These policies, stored on each of the user's trusted peers, are applied each time an inference request is submitted to one of these peers to access social information for the particular user. For availability, the policies are signed, encrypted and stored in the DHT, allowing only a rejoining trusted peer to recover updated policies (similarly with the social data). ACPs are comprised of two parts: the social data object(s) to be accessed and the specification(s) to be met before access is granted for the particular data object(s). They are defined as entries of the ACP U ID file in the following format: <Social Data Object(s)> :: <ACP Specification(s)>. Table I presents a list of such access control policy definitions. By design, ACPs are whitelists. Any of the specifications can be used to allow access to any of the data objects. Each of the data objects, as well as each of the specifications, can be combined with logical operators (e.g., AND, OR, NOT, etc.), to create more complex access policies. To verify the access rights, Prometheus may call its ACM Transactions on Internet Technology, Vol. V, No. N, Article A, Publication date: January YYYY. Enabling Social Applications via Decentralized Social Data Management A:11 inference functions, when applicable. For example, to detect whether the request's originating user is within n-hops, she is checked against the result of an n-hop neighborhood inference. ACPs also allow for blacklisted users (and their peers) for convenience. Given that it may take some time to discover malicious users or peers and update blacklists across the system, some attacks could take place. As future work, we plan to investigate the effective discovery and blacklisting of malicious peers, as well as the provision of strong consistency and conflict resolution for policies. Table I also shows an example of the set of access control policies for Bob. He allows work- related social information to be given to requests coming from users within 2 hops who are con- nected with him over LinkedIn label, or when these requests come from the CallCensor application. Also, he allows his parents and his brother to access his exact location at any time. If a neighbor- hood inference request for the Facebook label is submitted to Bob's trusted peer, Prometheus checks his ACP in the order Blacklist→labels→weights. Alice and Gary are excluded from all types of inferences and cannot receive any information about Bob. To protect their data from illegitimate access, users can set strict ACPs, for example, serving only requests originating from trusted 1-hop friends. Such ACPs will disallow 2-hop contacts from ac- cessing any data, but will also restrict the usability of multi-hop inferences such as social strength or neighborhood. Overall, we anticipate a tradeoff between how ACPs are defined to protect social data, and the usability of the platform through social inferences on these data. However, as demon- strated in the ACPs definition, users can fine-tune them to allow different access rights to particular sets of users, enabling inferences, and in extend applications, to maintain their functionality by accessing specific portions of user data. Table I: Access Control Policy Definitions and Examples. ACP Specifications Social Data Objects Social edge label α Social distance Social edge weight χ Social edge label User location ∆ Social edge weight ACP Examples ρ γ < χ = 0.3 >::< ρ = 1 AND S = Sof aSurf er > OR C = Charles) > y < ∆ >::< B = mom OR B = dad OR B = brother > B < α = Skype >::< ρ = 2 AND γ = Skype AND y = 0.2 > P < α = F acebook AND χ = 0.2 >::< ρ = 1 AND γ = F acebook > Originator user Originator peer Intermediate user C < α = LinkedIn >::< (ρ = 2 AND γ = LinkedIn) Intermediate peer M Application Originator's location L S < blacklist >::< B = Alice OR B = Gary > OR S = CallCensor > 5. PERFORMANCE EVALUATION To evaluate our system design, we used both simulations (Section 5.1) and experiments with a real implementation deployed on PlanetLab (Section 5.2). 5.1. Simulation Experiments We measured system performance, scalability and benefits from caching and geographic distribution of data on peers with three sets of experiments. In these tests, we simulated the inference function- alities of Prometheus while varying the size of stored social graphs, the type of data mapping on peers, the distribution of network delays, and data caching. 5.1.1. Experimental Setup. The two metrics used in this evaluation were expected response time to quantify the application-perceived performance, and number of P2P network messages to quan- tify the service overhead. We used synthetic bidirectional social graphs created with a genera- tor [Sala et al. 2010] which consistently produces graphs with properties such as degree distribution and clustering coefficient similar to real social graphs, but independent of the particularities of spe- cific real graphs (Table II). Edge weights were equally set to 0.1. We assumed open ACPs for all users, allowing access to all data from all users, thus stressing the system at maximum load. We ACM Transactions on Internet Technology, Vol. V, No. N, Article A, Publication date: January YYYY. A:12 N. Kourtellis et al. chose a random workload of 10% of graph users requesting data within 1 -- 3 hops, to investigate the system performance equally across all types of users (periphery and popular users alike). We examined a random and a social-based mapping of user data on peers. The social mapping corresponds to a realistic scenario where a group of socially-connected users share the resources of a peer contributed by a group member. For this mapping, the synthetic graphs were split into commu- nities using the Louvain community detection method [Blondel et al. 2008], then each community was mapped on a peer and we applied no data replication. Depending on the size of the graph used, the number of peers in the system varied between 1.5 and 166 thousand peers, with 6 -- 8 users/peer, on average. In the random mapping, user data are randomly grouped into sets of the same sizes as in the social mapping, and mapped on peers. We experimented with three network delay distributions for peer messages, simulating different geographical distributions of data. Using a P L-delay trace6 between 242 P L servers located in 21 countries, we extracted distribution delays for random peers, for peers within the same country, and for peers within the same continent. Thus, at the m-th network hop of an n-hop request, peers sent requests to other peers with a delay randomly selected from the delay distribution tested. The maximum delay for the m-th hop is used as its dominating network delay. The expected response time of a request is the sum of these maximum delays across all hops. We evaluated the benefits of data caching by storing the results seen from each peer and skipping unnecessary secondary requests the local cache could fulfill. Every t seconds the cache expired, depending on how frequently edges changed as observed on each peer from incoming social inputs. For simplicity, we assumed caches were always valid, i.e., an inter-arrival time of requests smaller than the cache expiration period. We validated our simulator using k-regular synthetic networks7 with similar properties as the synthetic social networks (same degree k and number of vertices) and confirmed that the results returned (i.e., messages sent/received) match the analytical calculations (in the order of O(2k(m−1)) for the m-th hop). We executed each setup 10 times and report statistically significant average values. Table II: Description of synthetic graphs used. AD: average degree, CC: clustering coefficient, ED: effective diameter, C: Number of communities, ACS: Average community size. Dataset 1k 10k 100k 1000k Nodes 1000 10 000 100 000 1 000 000 Edges 5895 58 539 587 970 5 896 878 AD 11.8 11.7 11.8 11.8 CC 0.263 0.219 0.207 0.204 ED 5.47 6.56 7.07 7.76 C ACS 7.58 6.40 6.37 6.01 132 1562 15 692 166 314 5.1.2. Scalability and Caching. Figure 3(a) shows the average number of messages sent between peers over different size graphs, with a detailed CDF for the graph of 1 million users in Fig. 3(d) (similar distributions were observed for the other graph sizes and are omitted for brevity). As ex- pected, increasing the graph size forces the system to exchange more P2P messages. The increase is small for 2-hop requests (5-10%) and larger in 3-hop requests (23-40%) in random mapping, and (25-30%) in social mapping. The social mapping needs fewer messages: about 50% of random in 2-hop (across all graph sizes) and 40-65% of random in 3-hop requests. When caching is enabled, the 2-hop requests do not benefit since secondary requests sent to other peers start from users con- necting different communities, and we never repeat requests from the same users. Instead, 3-hop requests significantly benefit: when the graph size increases, the increase in messages is reduced to 1-2% (from 20-40%) in both mappings. However, the social mapping still produces about 44-48% fewer messages than random, with the difference increasing with graph size. Figure 3(e) shows the effect of caching in subsequent requests: with 50% of requests executed (i.e., 50k requests in the 1M-user graph), the number of P2P messages drops by an order of magnitude. 6http://ridge.cs.umn.edu/pltraces.html 7The SNAP library was used (http://snap.stanford.edu/snap/index.html) with rewiring probability p = 0.1. ACM Transactions on Internet Technology, Vol. V, No. N, Article A, Publication date: January YYYY. Enabling Social Applications via Decentralized Social Data Management A:13 Fig. 3: Simulation results over various settings: Social (S) or Random (R) mappings; 2 (2H) or 3-hop (3H) requests; caching (C) or no-caching (NC); random, continent or country delays (RD, COD, CND). (a) Average P2P messages vs. graph sizes (y-bars show 95% confidence intervals). (b) Median network times vs. geo-distribution of peers (1M users) (y-bars show 1st and 3rd quartiles). (c) CDF of expected network time with no caching (1M users). (d) CDF of total P2P messages (1M users). (e) Average P2P messages vs. portion of 3-hop requests served (1M users). 5.1.3. Geo-distribution of peers. Figure 3(b) shows the median end-to-end response time needed for a 3-hop request to be fulfilled, given different geographical distributions of peers (random, in- continent or in-country). Also, Figure 3(c) shows the CDF of the time for 2 or 3-hop requests in the social mapping for the 1M-user graph. Considering median cases in the random delays (Fig 3(b)), requests in the social mapping are fulfilled 30-40% faster that in random for 3-hops (and 16-20% faster for 2-hops, not shown here). If socially-mapped peers send secondary requests to other peers within the same continent(country), the network times are 50% (70%) smaller than random delays for 2-hops, and about 38% (45%) for 3-hops (Fig 3(c)). When caching is enabled (Fig 3(b)), the social mapping with continent (country) delays reduces response times to 50% (67%) of the random delays in the 3 hops. 5.2. PlanetLab Experiments We implemented Prometheus on top of the FreePastry8 Java implementation of Pastry DHT which also provides API support for Scribe and Past. We performed various optimizations and fine tuning from our earlier work [Kourtellis et al. 2010b] to better handle the communication volatility and peer churn typically observed in a distributed infrastructure. We also redesigned the API to allow applications to submit a serializable class-based request by defining within the class object not only inference-specific parameters (such as label and weight) but also the new timeout parameter, which declares the application waiting time per hop when requesting multi-hop inferences. Furthermore, applications and peers can define parameters such as request id, timestamp and error flags. Overall, the new API design enhanced extensibility for future inference parameters, portability across dif- ferent platforms, and improved the peer-to-peer and peer-to-application communication during in- ference execution. We measured Prometheus' performance on PlanetLab (P L), a widely distributed network, and assessed the effect of socially-aware trusted peer selection on the system's overall performance. 8http://www.freepastry.org/ ACM Transactions on Internet Technology, Vol. V, No. N, Article A, Publication date: January YYYY. A:14 N. Kourtellis et al. 5.2.1. Experimental Setup. In these experiments we deployed the prototype on 100 selected P L peers worldwide (35 countries). We set the application timeout to 15 seconds/hop in the first set of experiments and tested lower timeouts in the second set. This timeout is needed to deal with communication delays due to long RTTs (125ms on average), busy network interfaces (the P L peers are shared resources), uncontrolled peer churn, and forwarding of requests. Prometheus uses this parameter to decide when to aggregate the intermediate results received so far and send them to the requesting peer. We note that the overall response time measured was dominated by the P L network delays (order of seconds) in comparison to the overhead for different local activities such as request parsing, decryption and signature verification and subgraph traversal on each peer (order of milliseconds); thus we focus We did not control the churn; peers were subjected to an average P L churn of ∼5%. To remove any bias from the data placement on faster or slower responding or failing peers, and the submission of requests from or to such peers, we distributed sets of data on randomly selected peers (thus enforcing random delays between peers) and each peer submitted application workload on behalf of all users. Edge weights were initially set to 0.1 and dynamically updated over time based on an empirically driven model explained in Section 5.2.3. In addition to the two metrics reported in simulations, we also measured the percentage of completion to quantify the tradeoff between request response time and level of request completion. The overloaded testbed led to increased communication delays while creating trusted peer lists. For a request for user x to be sent, an application has to first create x's T P L -- an operation which involves several time-consuming DHT lookups, resulting in multiple peer traversals -- and then for- ward the request to the first responding trusted peer. The distribution of the overhead associated with the cold start of creating a user's T P L over P L had a 50th, 90th and 99th percentile of 1.05, 2.15 and 8.78 seconds, respectively. Thus, for the majority of users this process can be fast, but for some users it can take as much as 8 -- 10 seconds (similar delays of 6 -- 10 seconds were reported for the Vis-a-Vis' group activities [Shakimov et al. 2009] running on P L). To mitigate this problem, Prometheus caches the T P L as explained in Section 4.2. As we are interested not in testing the DHT but Prometheus' performance in inference execution, our results show the performance using this caching mechanism and the direct peer communication layer (as discussed in Figure 1(b)). 5.2.2. Graph Decentralization. We used the 1k-user graph to reflect a realistic scenario of dis- tributing a social graph on 100 friend-contributed peers: each contributing user is trusted by a low number of relations. We vary this number from 10 to 50 (allowing replication), although one peer can handle requests for 1000 users with no performance penalty [Anderson 2010]. The scale of the graph and consequently of the P2P network tested is sufficient for evaluation of meaningful social inferences typically traversing a social neighborhood of 2-3 hops. 1000 users mapped on 100 peers provided enough variation for statistically significant measurements on a real deployment. We distributed the graph on P L peers using a random (as before) and a social mapping. The average number of users/peer received values N=10, 30 and 50 users/peer. The number of PL peers was kept constant to 100, forcing the user groups to overlap for N >10. This resembles the realistic scenario of overlapping social circles with some users participating in more than one circle (peer), and thus having multiple trusted peers. In effect, user data were replicated on K=N/10 peers on average, hence K=1, 3 and 5 trusted peers/user. To produce overlapping communities in the social mapping in a controlled fashion leading to the specific replication factors, we modified the community detection algorithm from [Girvan and Newman 2002] to control the number of communities and their average size. The algorithm takes as input the graph, the number of communities to be identified and the minimum acceptable community size. Then, it iteratively removes the highest betweenness centrality edge, if by removing it a new community of the desired size is created. Removal of edges continues until the specified number of communities is met. Users from a community are then mapped on the same peer. However, as previously mentioned, neighboring communities in the social graph were mapped on random peers ACM Transactions on Internet Technology, Vol. V, No. N, Article A, Publication date: January YYYY. Enabling Social Applications via Decentralized Social Data Management A:15 worldwide. This setup forced both geographically-close and socially-connected communities to be stored on random peers across the globe, enabling us to examine worse case random network delays. 5.2.3. Synthetic Workloads. We emulated the workload of a social sensor and two social applica- tions based on previous system characterizations. The sensor tested the platform's ability to manage and incorporate new social input under high-stress load. The user applications tested the end-to-end performance of the neighborhood and social strength requests. Edge weight update: We emulated a Facebook social sensor using the probability for users to post comments on walls and photos extracted from [Wilson et al. 2009]. To emulate an interaction from ego to alter, a random ego was selected based on their degree, and a random alter from ego's 1-hop friends. The weight of each input was kept constant to 0.01 for all users. Since users were picked based on their degree, users with higher degree probabilistically produced more input, leading to higher weights on their corresponding edges. Workload for Neighborhood Inference: A neighborhood request is a limited-distance flood in the network, similar to a tweet in Twitter. We used a Twitter trace analysis [Krishnamurthy et al. 2008] to associate a tweet with a neighborhood request (centered at the source of the tweet) in Prometheus. Users submitted neighborhood requests probabilistically based on their Twitter degree. The number of hops for the request was randomly picked from 1 -- 3 hops and the weight was randomly picked, with an upper bound of 0.1 to produce maximum request load in the system. Workload for Social Strength Inference: We used an analysis of BitTorrent traces to emulate the workload of a battery-aware BitTorrent application [King et al. 2009] on mobile devices: a user may rely on social incentives to be allowed to temporarily "free ride" the system when low on battery. Members of the same swarm check their social strength with the needy leecher to see if they want to contribute by uploading on her behalf. We assumed that users participated at random in BitTorrent swarms. Two users were randomly selected as the source and destination of the social strength inference request. The source user was associated with a total number of requests she would submit in the experiment. This number was extracted from a BitTorrent trace analysis [Guo et al. 2005]. 5.2.4. End-to-end performance on PlanetLab. For every setup, more than 1 million so- cial strength and neighborhood requests and more than 100 thousand edge updates were submitted from the emulated applications and social sensors running on the P L peers. Figures 4(a) -- (c) show the CDF of end-to-end average response time for the neighborhood inferences and the different setups. Since the social strength inference checks all possible 2-hop paths between two users, its results are almost identical to 2-hop neighborhood inferences and are omitted for brevity. As expected, the measured response time was higher than the simulations due to overloaded testbed: high average RTT (125ms), overloaded CPUs and network interfaces cards (it took 1-2 sec- onds just to establish a reliable T CP connection for the direct peer communications). Furthermore, the response time greatly depended on the hops requested. Larger hops lead to more peers contacted per hop (e.g., for a 3-hop request, and for 10 users/peer in social (random) mapping, ∼37(48) peers were contacted and ∼350 users returned). Thus, though the result aggregation is executed in paral- lel per hop, multiple peers must be contacted, which leads to dependency on a few slow-responding peers. We observe this in the flat regions of the CDFs, where ∼10 of 15secs timeout were spent waiting. However, an application can reduce the timeout to receive earlier some (incomplete) re- sults (shown next). 5.2.5. Response Time vs. Completion Rate. The previous experiments confirmed that a longer timeout (e.g., T =15seconds per hop) offers a high completion rate, even though the majority of this timeout (∼2/3) could be spent waiting for just a few slow peers to respond. We designed a second set of experiments to measure the tradeoff between response time and response completion rate. We varied the timeout T to 2.5, 5.0, 7.5, 10.0 seconds and used the social mapping with 30 users/peer. Figure 4(d) shows the CDF of the average completion percentage of the 3-hop neigh- borhood requests under different application-set timeouts. The results for 1 and 2 hops showed very high completion for all requests and timeouts and are omitted for brevity. Overall, we observe a clear ACM Transactions on Internet Technology, Vol. V, No. N, Article A, Publication date: January YYYY. A:16 N. Kourtellis et al. (a) 10 users per peer (b) 30 users per peer (c) 50 users per peer (d) 3-hop timeout Fig. 4: PlanetLab experiments on the 1k-user graph. (a) -- (c) CDF of average end-to-end response time of 1-3 hop neighborhood requests for social (S) vs. random (R) mapping of users on peers, and 10-50 users/peer. (d) CDF of average completion percentage of 3 -- hop neighborhood requests for varying timeouts. tradeoff between request completion rate and application waiting time for response. For example, when T =7.5(10)seconds, about 50%(80%) of requests have more than 90% completion. Thus, the longer an application is willing to wait, the more complete the information returned by the social inference is. A real-time social application -- e.g., "using the proximity inference, invite my 2-hop football contacts for celebration of the team's victory" -- could set a low timeout for quick, yet in- complete, results vs. the GamePartnerFinder application that can wait more time to get complete results. 5.3. Summary of lessons From the above simulation and PlanetLab experimental results we draw the following lessons on Prometheus' performance. Lesson 1: The social-based mapping of user data on peers improved the response times by 20- 25% and reduced the message overhead by 40 -- 65% in comparison to random. Such gains are observed in the cases of 10-30 users/peer (less for 50 users/peer), and for 2-3 hops; the 1-hop is computed either locally at the submitting peer or the first available trusted peer of the source user. Increasing the graph size and consequently the P2P network leads to higher overhead, but the social- based system exhibits half the overhead of random, both in simulations and in real deployment. Lesson 2: Increasing the service availability (through data replication) and number of users/peer does not always improve the response time and message overhead. In general, since requests for a ACM Transactions on Internet Technology, Vol. V, No. N, Article A, Publication date: January YYYY. 0 0.1 0.2 0.3 0.4 0.5 0.6 0.7 0.8 0.9 1 0 5 10 15 20 25 30 35CDFTime (s)random 1-hopsocial 1-hoprandom 2-hopsocial 2-hoprandom 3 hopsocial 3 hop 0 0.1 0.2 0.3 0.4 0.5 0.6 0.7 0.8 0.9 1 0 5 10 15 20 25 30 35CDFTime (s)random 1-hopsocial 1-hoprandom 2-hopsocial 2-hoprandom 3-hopsocial 3-hop 0 0.1 0.2 0.3 0.4 0.5 0.6 0.7 0.8 0.9 1 0 5 10 15 20 25 30 35CDFTime (s)random 1-hopsocial 1-hoprandom 2-hopsocial 2-hoprandom 3-hopsocial 3-hop 0 0.2 0.4 0.6 0.8 1 0 0.2 0.4 0.6 0.8 1CDFCompletion Percentage (%)2.5s 3-hop5.0s 3-hop7.5s 3-hop10.0s 3-hop Enabling Social Applications via Decentralized Social Data Management A:17 user can be fulfilled by any of her trusted peers, we observe that increasing the data availability by a factor of 3, and correspondingly increasing the number of users per peer, improves the end- to-end performance by up to 25% and reduces the message overhead by ∼30%. This performance gain is due to two reasons. First, having more user data on each peer allows more requests to com- plete with fewer network hops. Second, given peer churn and vulnerable P2P communication, more service availability per user means more alternative trusted peers to contact for a request to be ful- filled faster. However, when applying K=5 and N=50, we observe reduced improvements due to increased workload on each P L peer from the additional users mapped. Lesson 3: Caching inference results and geographic data decentralization can improve scala- bility and response time. Our simulations showed that caching leads to 20-40% message overhead reduction for request execution on larger systems with hundreds of thousands of peers and effec- tively allows the system to scale easier to larger graphs. Also, in our real deployment, by placing socially-close communities on random peers, we examined a pessimistic experimental scenario of longer than expected delays for request execution. However, in reality, we expect neighboring com- munities placed in geographically-close peers (e.g., same country) instead of random. In fact, in our simulations we observed that expected network times in a cached, social-based system with in-country delays, were 4 times smaller than in a non-cached social-based system with random delays. Given the similar network delay distributions observed in the P L-trace and our deploy- ment,9 we conjecture that geographic data placement of social groups on peers, in combination with caching of results, can lead to multiple times shorter response times. Given that social graphs rarely change [Golbeck 2007], background pre-computation and caching of results should allow the inference execution to scale easier to hundreds of thousands of peers, as shown in our simulations. 6. MOBILE APPLICATION PERFORMANCE We validated the usability of Prometheus as a social data management service by developing a mobile social application, CallCensor, that utilizes the Prometheus inference functions through the exposed API, under real-time constraints. Past work (ContextPhone [Raento et al. 2005]) described the ContextContact application which offers cues to the caller about the callee's social context such as location, collocation with other people, phone ringer status, etc. Our application builds on these lessons and allows the callee's phone to adjust the phone ring based on the owner's social context and the social relationship with the caller. We measured its end-to-end performance using a real multi-graph of 100 users. The CallCensor application leverages social information received from Prometheus to decide whether or not to allow incoming calls to go through. For each incoming call, the application queries Prometheus with a social strength or neighborhood inference request to assess the type of social connection between the caller and the phone owner. Based on the owner settings (e.g., don't allow personal calls while at work), the application decides if the phone should ring, vibrate or silence upon receiving the call. The application was written in Java for devices running Google Android OS and was tested on a Nexus One mobile phone from HTC (1GHz CPU, 512MB RAM). There are multiple scenarios a caller can be connected to the phone's owner; we tested three: directly connected within 1 social hop, indirectly connect by 2 social hops, and connected with a high social strength. We tested each of these scenarios 50 times. For each of them, the ego and alter were randomly chosen, and the inference request was sent to a random peer. We assumed users defined ACPs allowing access to all their data, thus enabling requests to proceed over multiple hops, and consequently stressing the system at maximum possible load. We measured the end-to- end response time of an inference request submitted to Prometheus. This experiment introduced additional overhead due to the communication between the mobile application and Prometheus, and the processing time by the mobile application. 9the P L-trace has an average RTT for random delays 4 times that of in-country delays over 21 countries, and the average RTT in our deployment for random delays was 6 times that of in-country delays over 35 countries. ACM Transactions on Internet Technology, Vol. V, No. N, Article A, Publication date: January YYYY. A:18 N. Kourtellis et al. Fig. 5: Real multi-graph with Facebook edges (black dashed lines) and collocation edges (red con- tinuous lines). Line thickness demonstrates edge weight. 6.1. Social Multi-Graph from Real Traces The social graph used in the CallCensor application experiments was based on data collected at NJIT [Pan et al. 2011]. The graph has two types of edges, representing Facebook friends and Blue- tooth collocation. Mobile phones were distributed to students and collocation data (determined via Bluetooth addresses discovered periodically by each mobile device) were sent to a server. The same set of subjects installed a Facebook application to provide their friend lists and participate in a sur- vey. The user set was small (100 users) compared to the size of the student body (9, 000), therefore resulting in a somewhat sparse graph. The collocation data have two thresholds of 45 and 90 minutes for users to have spent together. While the graph edges were not initially weighted, we applied synthetic weights of 0.1 for "Face- book" edges, 0.1 for "collocation" of 45 minutes and 0.2 for "collocation" of 90 minutes. For the mobile application experiments, we consider the "collocation" edges to represent a work relation- ship, while the "Facebook" edges represent a personal relationship. The user (ego) was assumed to be in a work environment when another user (alter) called. As shown in Figure 5, the multi-graph provided for better connectivity between users since neither the "Facebook" nor the "collocation" graph is connected, but the graph containing both types of edges is. We equally distributed the N JIT graph with a social mapping on three PL nodes. Splitting this 100 user-graph on 3 PL peers implies a similar ratio of users/peer as before, while testing 1 and 2 hop inference execution on a real multi-graph. 6.2. Experimental Results Figure 6 presents the performance for the requests sent by CallCensor, for each of the three scenar- ios examined. The results show the time spent by the requests only in Prometheus and the overall time needed by the CallCensor to request and handle a response. We first observe that the results meet the real-time constraint of the application: the response must arrive before the call is forwarded to the voicemail of the callee (we used the default voicemail time setting). Second, we notice that the application itself introduced a significant overhead: for example, as much as 100% in the 1 -- hop neighborhood and 50% in the 2 -- hop neighborhood and social strength, due to both communica- ACM Transactions on Internet Technology, Vol. V, No. N, Article A, Publication date: January YYYY. Enabling Social Applications via Decentralized Social Data Management A:19 Fig. 6: CDF of average end-to-end response time for CallCensor, under three social inference func- tion requests: 1, 2 hops neighborhood and social strength (SocS). tion overhead and execution time on the mobile phone. Third, we confirm the similarity of the social strength results with the neighborhood for 2 social hops, as found in the first set of experi- ments. Forth, the 2-hop request results using this small social graph are similar in performance with the larger 1000-user graph used before (social mapping, 30 users/peer). In particular, more than 80% of requests finished within 5 seconds in both setups, which leads us to believe that similar performance of the mobile application could be expected in a larger social graph distributed over hundreds of peers. 7. RESILIENCE TO MALICIOUS ATTACKS In this section, we discuss how the design characteristics of Prometheus enable the system to defend against attacks (1) at the infrastructure level, (2) at the social graph level, (3) at the service level, and (4) at the application level, or mitigate their effects on users. Attacks at the infrastructure level may attempt to install malcode in the system's software or firmware, or to hinder access with a denial of service attack. Both centralized and decentralized systems are vulnerable to such attacks. A decentralized system, however, can be the target of ad- ditional infrastructure attacks, such as to disrupt system communications (routing of messages be- tween peers) or content storage. Solutions to eclipse and other infrastructure attacks in DHT-based systems (such as Prometheus) have been discussed in the past [Urdaneta et al. 2011]. Attacks on the social graph aim to manipulate the graph structure by modifying edges, creating new edges with malicious users10 or bias honest users to reciprocate edges to attackers.11 A re- ciprocal edge to an attacker, as implemented in most OSNs, grants him partial or complete access to the victim's data (i.e., online profile and personal information) and can be used for email spam and phishing campaigns.12 Centralized systems have complete knowledge of the social graph and monitor its changes to detect such malicious activity (e.g., Facebook Immune System [Stein et al. 2011]). However, the effectiveness of their defense systems is currently limited against socialbot attacks [Boshmaf et al. 2011]. Prometheus' directed, labeled and weighted social graph is more dif- ficult to manipulate in such attacks because, while it is relatively easy to create an edge from the attacker to the victim, creating a useful reciprocal edge with appropriate label and weight is not in 10http://www.trendmicro.com/cloud-content/us/pdfs/security-intelligence/white-papers/wp the-real-face-of-koobface.pdf 11http://ca.olin.edu/2008/realboy/index.html 12http://www.symantec.com/connect/blogs/social-network-attacks-surge ACM Transactions on Internet Technology, Vol. V, No. N, Article A, Publication date: January YYYY. ��������������������������������������������������������������������������������������������������������������������������������������������������������������� A:20 N. Kourtellis et al. the attacker's control. In the future, Prometheus could employ techniques such as SybilLimit [Yu et al. 2008] to reduce further the probability to reciprocate edges to sybil attackers. Attacks at the service level attempt to manipulate inferences on the social graph, such as drop requests or modify results. Such attacks are more effective on decentralized systems than in centrally controlled systems due to the different level of guarantees that distributed, user-contributed peers can provide. We experimentally elaborate more on attacks at this level in the next subsections. Finally, at the application level, malicious services collect and use social data for spamming, stalking, etc. Users in centralized systems have typically limited or no control on the exposure and use of their data from such 3rd party services, as seen by numerous email spam and phishing campaigns, cyberstalking cases,13 as well as collection of private information from online social aggregators,14 or the NSA.15 Instead, Prometheus enables users to control access of applications to their social data via fine-grained ACPs. In addition, application designers can make use of the Prometheus API to reduce attacks on their users' data. For example, an email application could filter spam by allowing incoming emails only when the receiver is reciprocating an edge to the sender with appropriate label and weight, and even using knowledge from the receiver's 2-hop neighborhood to inform the filtering decision [Garriss et al. 2006]. Prometheus is useful to user applications only if it can support an unhindered execution of in- ference functionalities on users' social data. In the next subsections we discuss in more detail and present simulation results that show how the socially-aware design of Prometheus increases the system resilience to attacks at the service level which attempt to manipulate inference requests. 7.1. Attacks at the Service Level As explained in Section 4, if a peer does not have the social data necessary to fulfill a request locally, it sends secondary requests to the appropriate peers. The number of such secondary peers contacted depends on the request type and number of hops requested (which can translate to multiple P2P network hops) and how the social graph is decentralized on peers. Further, in a system that protects user privacy such as Prometheus, a requestor cannot distinguish how and from which peer any given item entered the result set. Consequently, for Alice to mount a successful attack at the service level, she would have to control intermediary peers, which have the opportunity to drop incoming requests, modify intermediate results, or change the parameters of secondary requests sent to new peers. Moreover, if malicious peers collude (e.g., they are all owned or have been compromised by Alice), they can increase the magnitude of the attack at the service level. Eavesdropping is disallowed due to encrypted P2P communication. Traffic analysis could reveal some characteristics of the network such as central peers that handle multiple requests. However, due to the chain-type of inference execution and the encrypted messages, an attacker would not be able to infer if they are requests, replies, etc., what type of requests (e..g, neighborhood), or what were the results returned. We experimentally investigate how the socially-aware design of Prometheus increases its re- silience to these attacks by measuring the opportunity of peers to influence (and thus manipulate) results when serving a neighborhood inference request. We define a peer's influence on requests as the fraction of requests that the peer serviced over the total number of requests issued in the system. A peer's influence on a request increases with the number of hops the graph is traversed, since, probabilistically, there are more chances for the peer to participate in the request's execution. We do not consider the first hop (i.e., the source peer) of a request as malicious, since if it is, no results can be considered legitimate. In these experiments we consider the worst case scenario where all requests traverse the whole graph: no restriction of the social edge label or weight, all edges are reciprocal, and users define ACPs allowing access to all their data. We extended our preliminary work [Blackburn et al. 2011] with two sets of experiments to assess the influence of peers in inference execution on real social graphs. During the experiments, an n- 13http://www.haltabuse.org/resources/stats/Cumulative2000-2011.pdf 14http://www.spokeo.com/ 15http://www.theguardian.com/world/prism ACM Transactions on Internet Technology, Vol. V, No. N, Article A, Publication date: January YYYY. Enabling Social Applications via Decentralized Social Data Management A:21 hop neighborhood request was performed for all egos (users) in the social graph. This request was submitted to ego's peer, i.e. peer P0, which could fulfill requests regarding information only about users mapped to P0. For users in subsequent social hops from ego that P0 did not have social data, P0 found the peers storing the particular users' data and submitted secondary requests to be fulfilled by those peers. Each time a peer served a secondary request, we increased the peer's influence. Similarly with Section 5.1.1, we validated our simulator for the influence measurements and report only statistically significant results. 7.2. Peer Influence in Independent Peer Attacks In our first set of experiments we studied the peer influence on five graphs based on real traces from diverse application domains, such as P2P file sharing (Gnutella), email communications (Enron), trust on consumer reviews (Epinions) and friendships in a news website (Slashdot). The social properties of these networks16 have been studied in the past [Gomez et al. 2008; Leskovec et al. 2009; Ripeanu et al. 2002] and represent possible activities that could connect Prometheus users with social edges of different labels. We considered all networks bidirectional with equally-weighted edges and used only the largest connected component of each graph to ensure reachability between all users. For social mappings of users to peers for the real graphs, we identified communities with the recursive-based Louvain method used in [Kourtellis and Iamnitchi 2011], for average community size N=10, 50 and 100, while maintaining the replication factor to one (K=1). Due to space, we present results for three of the networks and one of the community sizes but discuss lessons based on all networks and setups; all results can be found in [Kourtellis 2012]. We also compare results with the 1k-user synthetic graph used in Section 5. Table III presents a summary of the networks and communities found. Table III: Description of real graphs used (same graph metrics as in Table II). Dataset Nodes 10 876 62 561 82 168 Gnutella04 Gnutella31 Slashdot Edges 39 994 147 878 504 230 AD 7.4 4.7 12.3 CC ED 5.4 6.7 4.7 0.006 0.006 0.060 C ACS 10.0 10.0 10.0 1087 6255 8206 Fig. 7: Peer influence profile: CDF of the average peer influence for the 1000-user synthetic graph, the Gnutella04 graph (10.9K users), the Gnutella31 graph (62.6K users) and the Slashdot graph (82.2K users), for random (RM) and social mapping (SM) of 10 users/peer, for 2 and 3 hop re- quests. (Note: axes in log scale). 16Source: http://snap.stanford.edu/data/ ACM Transactions on Internet Technology, Vol. V, No. N, Article A, Publication date: January YYYY. 10-410-310-210-110010-510-410-310-210-1100CDFAverage InfluenceSynthetic Graph, 10u/pSM 2hRM 2hSM 3hRM 3h10-410-310-210-110010-510-410-310-210-1100Average InfluenceGnutella04, 10 u/p10-410-310-210-110010-510-410-310-210-1100Average InfluenceGnutella31, 10 u/p10-410-310-210-110010-510-410-310-210-1100Average InfluenceSlashdot, 10 u/p A:22 N. Kourtellis et al. Fig. 8: Peer influence profile: CDF of the average peer influence for the 1000-user synthetic graph, the Gnutella04 graph (10.9K users), the Gnutella31 graph (62.6K users) and the Slashdot graph (82.2K users), for random (RM) and social mapping (SM) of 50 users/peer, for 2 and 3 hop re- quests. (Note: axes in log scale). Figures 7 and 8 plot the CDF of the average influence of peers in 2 and 3 hop requests, for 10 and 50 users/peer respectively, for the Gnutella04, Gnutella31 and Slashdot graphs and the 1000-user synthetic graph used in Section 5. The results for all values of N and social graphs can be found in [Kourtellis 2012]. From these results we formulate the following lessons. Lesson 4: The social mapping reduces the average opportunity of peers to influence requests by 20 -- 50% for 2-hop requests and by 10 -- 40% for 3-hop requests in comparison to the random mapping. Figures 7- 8 show that the random mapping leads to an overall increased opportunity for peers to influence requests, in comparison to the social mapping, regardless of the type and size of graph, and number of hops. This is because in a social mapping, socially-close users are mapped to the same peers, increasing the likelihood that more hops are served locally when compared to randomly mapped users on peers. This implies that a social mapping results in fewer secondary requests sent in the system (regardless of the way communities were identified and mapped on peers). Furthermore, increasing the community size (not shown here) increases a peer's influence on requests, regardless of the type of mapping (random or social), since more requests are served by that peer for each of its users. However, this influence increase is more prominent in the random than in the social mapping. Lesson 5: The peer influence is affected more by the request's number of hops than the type of mapping, topology or the size of the distributed social graph. Malicious peers are more effective in small networks, as they can serve and thus influence a larger portion of requests. For example, Gnutella04 exhibited a similar influence profile with Gnutella31 but with higher influence values. Thus, even though they have the same topological characteristics, in the 6 times larger Gnutella31 peers have less opportunity to serve (portions of) requests. However, if we compare different-hop requests, in our tested graphs and values of users/peer, the average peer influence was higher by 1 -- 2 orders of magnitude in the 3-hop requests in comparison to 2-hops. Lesson 6: Social-based networks force peers to smaller influence values due to higher clustering coefficient and lower path length. Slashdot (and similarly Enron and Epinions [Kourtellis 2012]), have a different network structure than Gnutella, i.e., a higher clustering coefficient that reduces diameter and average path length, but also increases the average degree. In such social-based net- works, the peer influence spreads to a wider range (an order of magnitude smaller values), because queries cover smaller parts of the graph due to higher clustering coefficient and reduced path length. For these influence values (<0.1), the social mapping is more beneficial than random, since it forces ACM Transactions on Internet Technology, Vol. V, No. N, Article A, Publication date: January YYYY. 10-410-310-210-110010-510-410-310-210-1100CDFAverage InfluenceSynthetic Graph, 50u/pSM 2hRM 2hSM 3hRM 3h10-410-310-210-110010-510-410-310-210-1100Average InfluenceGnutella04, 50 u/p10-410-310-210-110010-510-410-310-210-1100Average InfluenceGnutella31, 50 u/p10-410-310-210-110010-510-410-310-210-1100Average InfluenceSlashdot, 50 u/p Enabling Social Applications via Decentralized Social Data Management A:23 requests to touch fewer peers. However, in higher influence values (>0.1), the social mapping per- forms similarly to random due to the presence of "hot-spot" peers. Lesson 7: The power-law nature of social graphs allows the formation of "hot-spot" peers who serve many requests, thus becoming attractive targets to attacks. We observe that in some of the networks, community sizes and n-hop requests, the social mapping can lead to a wider distribu- tion of peer influence values, when compared to the random mapping. This is particularly true in larger networks and community sizes. However, there are highly influential peers who control more requests flowing through the P2P topology than the average peer in both types of mappings. The emergence of such peers can be attributed to the power-law nature of social networks, where users of high social degree centrality attract a lot of the information flow and requests, regardless of the type of mapping enforced in the system. Even though such users are closely connected with each other [Shi et al. 2008] and are more likely to be mapped together on the same peer in the social than in the random mapping, in our experiments we observed that the random mapping also leads to such highly influential peers, especially in the larger graphs such as Epinions and Slashdot. To tackle the issue of potential attacks, peers can independently monitor the centrality they ac- quire in the P2P topology based on their users' centrality [Kourtellis and Iamnitchi 2011, 2013]. Consequently, a peer can drop requests from new users to store their social data and encourage them to seek alternative peers, if the new data would create uneven distribution of workload for the particular peer and lead to potential attacks. Thus, these hot-spot peers can be identified early and targeted for quarantine in the early stages of a malware outburst or other attack. Alternatively, they can be used to disseminate more efficiently security software patches to handle a malicious attack. 7.3. Peer Influence in Peer Collusion Attacks In the second set of experiments, we investigated the peer influence when peers collude with each other, e.g., they are all controlled by Alice. We assume that Alice attempts to recruit peers for her botnets in two ways. First, she targets random peers to control different parts of the network; we refer to this as random collusion (RC). Second, she targets a cluster of peers that serve a particular portion of the graph, e.g., neighboring groups in a large professional organization; we refer to this as social collusion (SC), since users mapped on the attacked peers are connected over social edges. For these experiments we used the largest network Slashdot and the social and random mappings with average community size of 10 users/peer. We seeded the collusion by selecting 1% random peers (i.e., 1% independent attackers). Then, we iterated over these peers to expand their collusion sets depending on the collusion type (social or random), until the overall malicious peers (fraction C of all peers) across all collusion sets amounted to a specific portion of the total network. We varied C in the range of 10%, 20%..., 50%. Figure 9 shows the average influence of peers for 10 repetitions of each of these scenarios. We observe that the average influence measured on collusion groups (SC or RC) is always higher than the average influence of their individual peer members when not colluding with each other (N C). From these results we draw several lessons. Lesson 8: Social mappings are more resilient to collusion attacks than random mappings. Col- lusion of peers increases their effectiveness when attacking the system. However, a random distri- bution of the social graph onto peers (RM) forces requests to access data from more peers than in a social distribution (SM), and thus allows peers to control and influence a higher portion of inference requests, either if they are colluding or not. Lesson 9: Social peer collusions are less effective on social than random mappings. In the social collusion, the attack targets neighboring peers (i.e., their users are directly connected in the social graph). In this case, the attacker achieves lower peer influence on requests if the graph was mapped with a social than a random mapping. Overall, the difference between social and random collusion is limited to ∼2% in 2 hops, ∼10% in 3 hops and ∼5% in 4 hops. Lesson 10: The peer influence is affected more by the request's number of hops than the collusion size. In all tested collusion types and graph mappings, increasing the number of colluding peers increases the average peer influence of an attacker. However, the peer influence value depends more ACM Transactions on Internet Technology, Vol. V, No. N, Article A, Publication date: January YYYY. A:24 N. Kourtellis et al. Fig. 9: Average peer influence for random (RM) and social mapping (SM) of Slashdot, for 10 users/peer, 2 -- 4 hop requests and varying range of social (SC) or random collusion (RC). We compare with the no-collusion (N C) scenario. Y-bars show 95% confidence intervals. on the number of hops the request will traverse the graph, than the collusion size: from less than 10% for 2 hops to more than 90% for 4 hops (as also shown in the previous experiments). We also observe highest gains on the rate of change of peer influence for a malicious attacker at 3 hop requests than 2 or 4 hops (the 4 hop requests cover most of Slashdot). Overall, our experiments demonstrated that the social mapping of user data onto Prometheus peers leads to improved resilience to attacks during request execution, since peers have reduced opportunity to manipulate requests and their results, in comparison to a random mapping (e.g., using a DHT). Furthermore, we observed that a social peer collusion can be more effective than a random peer collusion. Therefore, users should carefully select their trusted peers, since unverified peers from their social neighborhood can potentially have increased influence on their requests than random peers. Finally, there should be default ACPs to control the number of (social and network) hops that requests can travel in the system, since this parameter is more important with respect to peer influence and data exposure, than the extend of peer collusion. 8. CONCLUSIONS We presented Prometheus, a P2P service that provides decentralized, user-controlled, social data management. Its directed, weighted, labeled and multi-edged social graph offers an aggregate rep- resentation of users' social state. It enables novel socially-aware applications to mine this rich graph via an API that executes social inferences, while enforcing user-defined access control policies. We evaluated the Prometheus design via large-scale simulations and a prototype deployment on a large distributed testbed with realistic workloads. Prometheus is designed as an application-oriented platform. Thus, we tested its end-to-end performance and showed that deadlines set by application requests can be met without significant reduction in the quality of results. Additionally, we imple- mented a proof-of-concept mobile social application that utilizes Prometheus functionalities under real-time deadlines. Further, we investigated the resilience of Prometheus to attacks by malicious users or peers, and established that the socially-aware design of Prometheus constitutes a resilient P2P system that can withstand malicious peer attacks more effectively than solutions that randomly distribute users' data onto peers. Acknowledgments This research was supported by the National Science Foundation under Grants No. CNS 0952420, CNS 0831785 and CNS 0831753. Any opinions, findings, and conclusions or recommendations expressed in this material are those of the authors and do not necessarily reflect the views of the sponsors. The authors would like to acknowledge the contributions of Joshua Finnis and Paul Anderson in the Prometheus code and PlanetLab experiments. ACM Transactions on Internet Technology, Vol. V, No. N, Article A, Publication date: January YYYY. 0.000.010.020.030.040.050.060.070.08 10 20 30 40 50Average InfluencePortion C (%)2 social hops0.000.100.200.300.400.500.600.70 10 20 30 40 50Portion C (%)3 social hopsNC-SM-RCNC-RM-RCNC-SM-SCNC-RM-SC0.650.700.750.800.850.900.951.00 10 20 30 40 50Portion C (%)4 social hopsRC-SMRC-RMSC-SMSC-RM Enabling Social Applications via Decentralized Social Data Management A:25 REFERENCES L.M. Aiello and G.Ruffo. 2012. LotusNet: Tunable privacy for distributed online social network services. Computer Communications 35, 1 (December 2012), 75 -- 88. Paul Anderson. 2010. GeoS: A Service for the Management of Geo-Social Information in a Dis- tributed System. Master's thesis. University of South Florida. P. Anderson, N. Kourtellis, J. Finnis, and A. Iamnitchi. 2010. On Managing Social Data for Enabling Socially-Aware Applications and Services. In 3rd ACM Workshop on Social Network Systems. Paris, France. F. Benevenuto, T. Rodrigues, M. Cha, and V. Almeida. 2009. Characterizing User Behavior in Online Social Networks. In 9th ACM Internet Measurement Conference. Chicago, USA. J. Blackburn, N. Kourtellis, and A. Iamnitchi. 2011. Vulnerability in Socially-Informed Peer-to-Peer Systems. In 4th ACM Workshop on Social Network Systems. Salzburg, Austria. V. D. Blondel, J-L. Guillaume, R. Lambiotte, and E. Lefebvre. 2008. Fast unfolding of communities in large networks. Journal of Statistical Mechanics: Theory and Experiment 10 (2008). Y. Boshmaf, I. Muslukhov, K. Beznosov, and M. Ripeanu. 2011. The Socialbot Network: When Bots Socialize for Fame and Money. In 27th Annual Comp. Security Applications Conf. (ACSAC). S. Buchegger, D. Schioberg, L.H. Vu, and A. Datta. 2009. PeerSoN: P2P social networking: early experiences and insights. In 2nd ACM Workshop on Social Network Systems. Nuremberg, Ger- many, 46 -- 52. M. Castro, P. Druschel, A.M. Kermarrec, and A. Rowstron. 2002. Scribe: A large-scale and decen- tralized application-level multicast infrastructure. IEEE Journal on Selected Areas in Communi- cations 20, 8 (2002), 1489 -- 1499. L.A. Cutillo, R. Molva, and T. Strufe. 2010. On the Security and Feasibility of Safebook: A Dis- tributed Privacy-Preserving Online Social Network. Privacy and Identity Management for Life 320 (2010), 86 -- 101. N. Eagle and A.S. Pentland. 2006. Reality mining: sensing complex social systems. Personal and Ubiquitous Computing 10, 4 (2006), 255 -- 268. N. E. Friedkin. 1983. Horizons of Observability and Limits of Informal Control in Organizations. Social Forces 62, 1 (1983), 57 -- 77. S. Garriss, M. Kaminsky, M. J. Freedman, B. Karp, D. Mazi`eres, and H. Yu. 2006. RE: Reliable Email. In 3rd USENIX Symposium on Networked Systems Design and Implementation. San Jose, CA, USA, 297 -- 310. B. Gellman and L. Poitras. 2013. U.S., British intelligence mining data from nine U.S. Internet (2013). http://www.washingtonpost.com/investigations/ companies in broad secret program. us-intelligence-mining-data-from-nine-us-internet-companies-in-broad-secret-program/2013/ 06/06/3a0c0da8-cebf-11e2-8845-d970ccb04497 story.html M. Girvan and M. E. J. Newman. 2002. Community structure in social and biological networks. National Academy of Sciences of USA 99, 12 (2002), 7821 -- 7826. J Golbeck. 2007. The dynamics of web-based social networks: Membership, relationships, and change. First Monday 12, 11 (Nov 2007). S. A. Golder, D. Wilkinson, and B. A. Huberman. 2007. Rhythms of social interaction: messaging within a massive online network. In 3rd International Conference on Communities and Technolo- gies. MI, USA. V. Gomez, A. Kaltenbrunner, and V. Lopez. 2008. Statistical Analysis of the Social Network and Discussion Threads in Slashdot. In 17th ACM International Conference on World Wide Web. 645 -- 654. K. Graffi, C. Gross, D. Stingl, D. Hartung, A. Kovacevic, and R. Steinmetz. 2011. LifeSocial.KOM: A Secure and P2P-Based Solution for Online Social Networks. In Consumer Communications and Networking Conference (January). Las Vegas, NV, USA. L. Guo, S. Chen, Z. Xiao, E. Tan, X. Ding, and X. Zhang. 2005. Measurements, analysis, and modeling of BitTorrent-like systems. In 5th ACM Internet Measurement Conference. Berkeley, ACM Transactions on Internet Technology, Vol. V, No. N, Article A, Publication date: January YYYY. A:26 N. Kourtellis et al. USA, 35 -- 48. A. Iamnitchi, J. Blackburn, and N. Kourtellis. 2012. The Social Hourglass: an Infrastructure for IEEE Internet Computing, Special Issue on Social Socially-aware Applications and Services. Networking Infrastructures 16, 3 (May/June 2012), 13 -- 23. J. Jiang, C. Wilson, X. Wang, P. Huang, W. Sha, Y. Dai, and B. Y. Zhao. 2010. Understanding Latent Interactions in Online Social Networks. In 10th ACM Internet Measurement Conference. Melbourne, Australia. Z. King, J. Blackburn, and A. Iamnitchi. 2009. BatTorrent: A Battery-Aware BitTorrent for Mobile Devices. In 11th International Conference on Ubiquitous Computing, Poster Session. Orlando, FL, USA. J. S. Kong, B. A. Rezaei, N. Sarshar, V. P. Roychowdhury, and P. O. Boykin. 2006. Collaborative Spam Filtering Using E-Mail Networks. Computer 39, 8 (2006), 67 -- 73. Nicolas Kourtellis. 2012. On the Design of Socially-Aware Distributed Systems. Ph.D. Dissertation. University of South Florida. N. Kourtellis, J. Finnis, P. Anderson, J. Blackburn, C. Borcea, and A. Iamnitchi. 2010b. Prometheus: User-Controlled P2P Social Data Management for Socially-Aware Applications. In 11th ACM/IFIP/USENIX International Middleware Conference (November). Bangalore. N. Kourtellis, J. Finnis, P. Anderson, J. Blackburn, and A. Iamnitchi. 2010a. Prometheus: Dis- tributed Management of Geo-Social Data. In 7th USENIX Symposium on Networked Systems Design and Implementation. San Jose, California. N. Kourtellis and A. Iamnitchi. 2011. Inferring Peer Centrality in Socially-Informed Peer-to-Peer Systems. In 11th IEEE International Conference on Peer-to-Peer Computing. Kyoto, Japan. N. Kourtellis and Adriana Iamnitchi. 2013. Leveraging peer centrality in the design of socially- informed P2P systems. IEEE Transactions on Parallel and Distributed Systems (April 2013). B. Krishnamurthy, P. Gill, and M. Arlitt. 2008. A Few Chirps About Twitter. In 1st Workshop on Online Social Networks. Seattle, WA, USA, 19 -- 24. J. Leskovec, K. J. Lang, A. Dasgupta, and M. W. Mahoney. 2009. Community structure in large net- works: Natural cluster sizes and the absence of large well-defined clusters. Internet Mathematics 6, 1 (2009), 29 -- 123. K. Lewis, J. Kaufman, M. Gonzalez, A. Wimmer, and N. Christakis. 2008. Tastes, ties, and time: A new social network dataset using Facebook.com. Social Networks 30, 4 (2008), 330 -- 342. J. Li and F. Dabek. 2006. F2F: reliable storage in open networks. In 5th Int. Workshop on Peer-to- Peer Systems. Santa Barbara, CA, USA. Y. Matsuo, J. Mori, M. Hamasaki, K. Ishida, T. Nishimura, H. Takeda, K. Hasida, and M. Ishizuka. 2006. POLYPHONET: an advanced social network extraction system from the web. In 15th ACM International Conference on World Wide Web. 397 -- 406. S.B. Mokhtar, L. McNamara, and L. Capra. 2009. A Middleware Service for Pervasive Social Networking. In 1st Workshop on Middleware for Pervasive Mobile & Embedded Computing. Urb. Champ., USA. T. D. Nguyen, F. Chiang, and J. Li. 2008. Friendstore: cooperative online backup using trusted nodes. In 1st International Workshop on Social Network Systems. Glasgow, Scotland, 37 -- 42. S.J. Pan, D. J. Boston, and C. Borcea. 2011. Analysis of fusing online and co-presence social networks. In 2nd Workshop on Pervasive Collaboration and Social Networking (March). Seattle, WA, USA. A-K Pietilainen, E. Oliver, J. LeBrun, G. Varghese, and C. Diot. 2009. MobiClique: Middleware for Mobile Social Networking. In 2nd Workshop on Online Social Networks. Barcelona, Spain, 49 -- 54. M. Raento, A. Oulasvirta, R. Petit, and H. Toivonen. 2005. ContextPhone: A Prototyping Platform for Context-Aware Mobile Applications. Pervasive Computing, IEEE 4 (2005), 51 -- 59. M. Ripeanu, A. Iamnitchi, and I. Foster. 2002. Mapping the Gnutella network. IEEE Internet Computing 6, 1 (2002), 50 -- 57. Sam G B Roberts and Robin I M Dunbar. 2010. The costs of family and friends: an 18-month ACM Transactions on Internet Technology, Vol. V, No. N, Article A, Publication date: January YYYY. Enabling Social Applications via Decentralized Social Data Management A:27 longitudinal study of relationship maintenance and decay. Evolution and Human Behavior 32, 3 (2010), 186 -- 197. A. Rowstron and P. Druschel. 2001a. Pastry: Scalable, Decentralized Object Location, and Rout- ing for Large-Scale Peer-to-Peer Systems. In 1st ACM/IFIP/USENIX International Middleware Conference. Heidelberg, Germany, 329 -- 350. A. Rowstron and P. Druschel. 2001b. Storage management and caching in PAST, a large-scale, persistent peer-to-peer storage utility. In 18th SOSP. Banff, Alberta, Canada, 188 -- 201. A. Sala, L. Cao, C. Wilson, R. Zablit, H. Zheng, and B. Y. Zhao. 2010. Measurement-calibrated Graph Models for Social Network Experiments. In 19th ACM International Conference on World Wide Web. Raleigh, USA, 861 -- 870. E. Sarigol, O. Riva, and G. Alonso. 2010. A Tuple Space for Social Networking on Mobile Phones. In 26th International Conference on Data Engineering. Long Beach, CA, USA, 988 -- 991. A. Shakimov, A. Varshavsky, L.P. Cox, and R. C´aceres. 2009. Privacy, cost, and availability tradeoffs in decentralized OSNs. In 2nd Workshop on Online Social Networks. Barcelona, Spain, 13 -- 18. X. Shi, M. Bonner, L. Adamic, and A. C. Gilbert. 2008. The Very Small World of the Well- connected. In 19th Conf. on Hypertext and Hypermedia. Pittsburgh, PA, USA. T. Stein, E. Chen, and K. Mangla. 2011. Facebook Immune System. In 4th ACM Workshop on Social Network Systems. Salzburg, Austria. TheGuardian. 2014. The NSA files. (2014). http://www.theguardian.com/us-news/the-nsa-files A. Toninelli, A. Pathak, and V. Issarny. 2011. Yarta: A Middleware for Managing Mobile Social Ecosystems. In 6th Conference on Advances in Grid and Pervasive Computing (May). Finland, 209 -- 220. G. Urdaneta, G. Pierre, and M. van Steen. 2011. A Survey of DHT Security Techniques. Comput. Surveys 43, 2 (Jan 2011). Barry Wellman. 1988. Structural analysis: From method and metaphor to theory and substance. Social structures: A network approach. (1988), 19 -- 61. C. Wilson, B. Boe, A. Sala, K. P. N. Puttaswamy, and B. Y. Zhao. 2009. User Interactions in Social Networks and their Implications. In 4th ACM European Conference on Computer Systems. Nuremberg, Germany, 205 -- 218. R. Xiang, J. Neville, and M. Rogati. 2010. Modeling relationship strength in online social networks. In 19th ACM International Conference on World Wide Web. Raleigh, NC, USA, 981 -- 990. H. Yu, P. B. Gibbons, M. Kaminsky, and F. Xiao. 2008. SybilLimit: A Near-Optimal Social Network Defense against Sybil Attacks. In IEEE Symposium on Security and Privacy. 3 -- 17. ACM Transactions on Internet Technology, Vol. V, No. N, Article A, Publication date: January YYYY.
1909.13628
1
1909
2019-09-30T12:35:32
The vulnerability of communities in complex network: An entropy approach
[ "cs.SI" ]
Measuring the vulnerability of communities in complex network has become an important topic in the research of complex system. Numerous existing vulnerability measures have been proposed to solve such problems, however, most of these methods have their own shortcomings and limitations. Therefore, a new entropy-based approach is proposed in this paper to address such problems. This measure combines the internal factors and external factors for each communities which can give the quantitative description of vulnerability of community. The internal factors contain the complexity degree of community and the number of edges inside the community, and the external factors contain the similarity degree between chosen community and other communities and the number of nodes outside the community. Considering community vulnerability from the perspective of entropy provides a new solution to such problem. Due to sufficient consideration of community information, more reasonable vulnerability result can be obtained. In order to show the performance and effectiveness of this proposed method, one example network and three real-world complex network is used to compare with some exiting methods, and the sensitivity of weight factors is analysed by Sobol' indices. The experiment results demonstrate the reasonableness and superiority of this proposed method.
cs.SI
cs
The vulnerability of communities in complex network: An entropy approach Tao Wena, Yong Denga,∗ aInstitute of Fundamental and Frontier Science, University of Electronic Science and Technology of China, Chengdu, 610054, China Abstract Measuring the vulnerability of communities in complex network has become an important topic in the research of complex system. Numerous existing vulnerability measures have been proposed to solve such problems, however, most of these methods have their own shortcomings and limitations. There- fore, a new entropy-based approach is proposed in this paper to address such problems. This measure combines the internal factors and external factors for each communities which can give the quantitative description of vulner- ability of community. The internal factors contain the complexity degree of community and the number of edges inside the community, and the external factors contain the similarity degree between chosen community and other communities and the number of nodes outside the community. Consider- ing community vulnerability from the perspective of entropy provides a new solution to such problem. Due to sufficient consideration of community in- formation, more reasonable vulnerability result can be obtained. In order to ∗Corresponding author at: Institute of Fundamental and Frontier Science, University of Electronic Science and Technology of China, Chengdu, 610054, China. E-mail: dengen- [email protected], [email protected].(Yong Deng) Preprint submitted to Reliability Engineering & System Safety October 1, 2019 show the performance and effectiveness of this proposed method, one exam- ple network and three real-world complex network is used to compare with some exiting methods, and the sensitivity of weight factors is analysed by Sobol' indices. The experiment results demonstrate the reasonableness and superiority of this proposed method. Keywords: Complex network, Community vulnerability, Entropy 1. Introduction Recently, cyber-physical system (CPS) has attracted much attention in nu- merous fields, such as microgrid [1], smart city [2], internet of things [3, 4], and so on. Meanwhile, how to model CPS into specific physical models to analyze their performance and property has become the focus of research [5]. Therefore, complex network has been applied in this field to better under- stand the performance of CPS [6, 7], because nodes in the network represent individuals in the system, and edges would show the relationship between these individuals. Most of previous researches focus on the structure and topological property, which can quantify the characteristic and performance of network. Particularly, the community structure has received increasing attention, because it can reveal human dynamics [8, 9], inference reliable links [10], and identify influential nodes [11, 12]. The community structure in the network demonstrates a higher density of nodes and edges, which can cause critical influence on the function and structure of subnetwork, improve the reliability of system [13, 14], and counteract the aging effect [15, 16]. There are several different problems about the research of community struc- ture, which can be divided into two issues. The first one is about the struc- ture of community, such as dividing network's community structure [17 -- 19], 2 detecting overlapping community [20], and dynamic changes of community in evolving network [21]. Another one is the property of community, in- cluding measuring the reliance of community [22 -- 24], reconfiguring network [25], quantifying the reliability of community[26, 27], and measuring commu- nity vulnerability [28]. The vulnerability of community in network gradually aroused researchers' interest recently. For example, Rocco et al. [29] defined vulnerability set and value for different community, and proposed relative vulnerability value to compare with remaining communities. Wei et al. [30] proposed a measure which consider more information about community it- self, and used non-linear weighted function to combine these factors. Aniko et al. [31] proposed a topological index (distance-based fragmentation) to quantify the structural vulnerability in plant-visitation network. Alim et al. [32] assessed the community vulnerability through social-based forwarding and routing methods in opportunistic networks, which shows significant con- tribution about some devices on the performance of entire network. Che et al. [33] modified original evolution method, and proposed a nondimension- alized scoring standard to form a complete assessment system to measure the vulnerability of urban power grid. Chen et al. [34] explored the rela- tionship between vulnerability of complex network and fractal dimension. These methods have their own limitations, like computational complexity, inaccurate measurements, and not suitable for certain scenarios. Since entropy is an useful tool to measure the uncertain of information [35, 36], it has been wildly in the network theory, like dimension presenta- tion [37 -- 39], evidence theory [40, 41], influential nodes identification [42, 43], time series prediction [44, 45]. In addition, the structure and property of communities can be expressed by probability sets, entropy-based method has gradually been an reasonable and effective method to quantify the prop- erty of network [46, 47]. Therefore, an entropy approach is applied in this 3 paper to measure the vulnerability of community which can overcome the shortcomings and limitations of previous method. In this paper, an entropy-based measure is proposed to quantify the vulner- ability degree of community structure. This proposed method can combine two parts of information, i.e., internal factors and external factors, which can consider more information about community and give a reasonable vulnera- bility result of each community. The internal factors contains the number of edges inside the community and the complexity degree of community which is measured by Tsallis structure entropy, and the external factors contains the number of edges outside the community and the similarity degree between chosen community and other communities which is measured by relative en- tropy. These two entropy can quantify the property of community more reasonable and effective. Finally, the vulnerability and relative vulnerability result can be obtained by this proposed method to quantitatively describe vulnerability of different community. In order to show the performance and effectiveness of this proposed method, one example network and three real- world complex network are applied in this paper. In addition, the sensitive of four weight factors are analysed by Sobol' indices in Manzi network, and the vulnerability order obtained by different method are compared in Italian 380KV power grid network. The experiments results show the superiority and reasonableness of this proposed method, meanwhile, this proposed method can overcome the shortcomings and limitations of previous method, The organization of the rest of this paper is as follows. Section 2 presents some basic properties about node and detecting community methods. This novel entropy-based method is proposed in Section 3 to measure the vul- nerability of community. Meanwhile, numerical experiments are performed to illustrate the reasonableness and effectiveness of the proposed method in 4 Section 4. Conclusion is conducted in Section 5. 2. Preliminaries In this section, some basic concepts about complex network are introduced. In addition, a community detection algorithm and classical community vul- nerability measure are described in this section. 2.1. Node properties in network A given complex network can be denoted as G(N, E), where N = (1, 2, · · · , n) and E = (1, 2, · · · , m) is the set of nodes and edges respectively, and n and m is the number of nodes and edges in the complex network respectively. A is the adjacency matrix of complex network whose size is n×n, where aij = 1 represents there is an edge between node i and node j, and aij = 0 is the opposite. Definition 2.1. (Node Degree). The degree of node i in the complex network is denoted as di and defined as follows, n di = aij (1) Definition 2.2. (Node Betweenness). The betweenness distribution of node i in the complex network is denoted as pi ′ and defined as follows, gse(i) gse pi ′ = Xs,e6=i 5 (3) where aij is one element of adjacency matrix A. The degree distribution of node i is defined as follows, pi = di (2) Xj=1 di Pi∈N where gse is the total number of shortest paths between node s and node e, and gse(i) is the number of shortest paths between node s and node e which pass through node i. 2.2. Community detection algorithm Lots of measures have been proposed to detect the community structure in complex network. In order to find the community structure of network, Newman's modularity method [48] is applied in this paper. Definition 2.3. (Newman's modularity). For a given complex network G with k communities, the modularity is denoted as Q and defined as follows, Q = k Xck=1 eck m −(cid:18) Degck 2m (cid:19)2! (4) where k is the number of communities, m is the total number of edges in complex network, eck is the number of edges in community ck, and Degck is the total degree of nodes in community ck which is defined as follows, Degck =Xi∈ck di (5) where ck is the set of nodes in community, and di is the degree of node i. The value of Q can measure the difference of different communities which can show the presence of community structure in complex network. Differ- ent value of Q represents different situation. Q = 0 means all of the nodes in the network are in one single community and there is no community struc- ture in the network. Q > 0 represents there are some kinds of community structure, and Q = 1 means the community structure is strong in the net- work. Meanwhile, Newman and Girvan [49] suggested the value of Q should 6 fall in the range 0.2 ∼ 0.7, and this value of Q would show the existence of community structures. The main idea of this method is to find the changes in Q, and the step to detect community structure is shown as follows, Step 1: Each node in the complex network is divided in a single community. Step 2: Every two communities are integrated into one community in turn, and the value of modularity change ∆Qij can obtained from the community structure. Step 3: Community i and community j are integrated into one community with the highest ∆Qij. Step 4: Repeat Step 2 and Step 3 until ∆Qij < 0. 2.3. Classical community vulnerability measure To measure the vulnerability of community, lots of measures have been pro- posed. One classical measure is introduced in this section. Definition 2.4. (Community vulnerability measure). The vulnerability of community x is denoted as vx and defined as follows, vx = 1 Vx , ∀Vx 6= ∅ (6) where Vx is the set of communities which are connected with community x, and Vx is the number of links which are connected with community x. The relative vulnerability of community x is denoted as Rx and defined as 7 follows, Rx = vx v , v = min y (vy) (7) 3. The proposed method 3.1. Basic method In this section, a novel method is proposed to measure community vulner- ability via entropy approach. This proposed method focuses two parts of information which can consider more details in the network, including inter- nal factors and external factors. The internal factors include the complexity degree of community and number of edges within the community, and exter- nal factors include the similarity degree and number of edges between chosen community and other communities. The complexity and similarity would be obtained by entropy method which would overcome the shortcomings and limitations of previous method. The flow chart of this proposed method is shown in Fig. 1. 3.1.1. Complexity measure Firstly, the complexity degree of community is measured by Tsallis structure entropy which combines the degree distribution and betweenness distribu- tion. Because degree distribution focuses on the local topological information of central node and betweenness distribution considers the global topological information, Tsallis structure entropy which combines these two topological information can give a reasonable measure for community complexity. Definition 3.1. (Complexity measure based on Tsallis structure entropy). The complexity degree of community ck is denoted as Tck and defined as 8 Community structure Degree distribution Betweenness distribution External factors Relative entropy Tsallis structure entropy Internal factors Number of edges outside community Similarity degree Complexity degree Number of edges inside community Community vulnerability Fig. 1: The flow chart of this proposed method. follows, ck qi − pi pi 1 − qi (8) Tck = Xi=1 where ck is the number of nodes in community ck, pi is the degree distribution node i which can be obtained by Eq. (2), qi can be obtained from betweenness distribution, and the relationship between qi and pi ′ is shown as follows, qi = 1 + (pmax ′ − pi ′) (9) ′ can be obtained from Eq. (3), pmax where pi tweenness pi which can show the influence of subnetwork to community ck. ′ is the maximum value of be- ′. The purpose of Eq. (9) is to make the index qi bigger than 1 When each node's qi equals to 1, Tsallis entropy would degenerate to Shannon 9 entropy which is shown as follows, Tck = − pi log pi ck Xi=1 (10) This form of entropy would only focuses on the local topological structure information. The degree distribution is based on the local topological structure around central node i. The betweenness distribution focuses on the whole topologi- cal structure which can describe the global properties of community. Most of time, qi would be bigger than 1 which can show the influence of subnetwork. When each nodes's qi equals to 1, the Tsallis entropy would degenerate to Shannon entropy based on degree distribution which only focuses on the local structure. Using betweenness distribution to replace the constant parameter q can describe the information about the network itself which is more rea- sonable for measuring the communities' complexity. This method's property also obeys the classical Tsallis entropy. 3.1.2. Similarity measure Then, relative entropy is used in this section to obtain the similarity de- gree of chosen community and other communities. The relative entropy (Kullback−Leibler divergence) was wildly used in information theory and probability theory which is proposed by Kullback and Leibler et al. [50]. In general, the relative entropy is used to measure the difference between two probability set. In this section, the relative entropy is based on Shannon entropy and degree distribution which can measure the similarity between two community structure. 10 For two community ci and cj, the community structure is denoted as Lci(Ni, Di) and Lcj (Nj, Dj) respectively, where Ni and Di is the set of nodes and set of Ni is the number of nodes in commu- degree of nodes in community ci. nity ci and max Ni is the maximum size of community in the network. The probability set of community i is denoted as P (i) and obtained by degree dis- tribution. The scale of every probability set s would be same which equals to max Ni. So the probability set of community ci can be shown as follows, P (i) = [p(i, 1), p(i, 2), · · · , p(i, s)] (11) The element in probability set is based on degree distribution. When the size Ni of community ci equals to max Ni, all of the elements would be obtained by nodes' degree, but when Ni < max Ni, some elements would equal to zero to make the probability set complete. The detail of p(i, k) is defined as follows, k ≤ Ni dk Ni P k=1 dk 0 k > Ni (12) p(i, k) =  where dk is the degree of node k, Ni is the number of nods in community ci. To measure the similarity between community ci and cj, the relative entropy is used in this section and it is defined as follows, Definition 3.2. (Similarity measure based on relative entropy). The differ- ence between two communities is obtained by relative entropy Rij and defined as follows, Rij(P ′(i)P ′(j)) = p′(i, k) log p′(i, k) p′(j, k) (13) Because the order of element would affect the relative entropy and similarity result, p′(i, k) and p′(j, k) are the decreasing order of p(i, k) and p(j, k) in s′ Xk=1 11 Eq. (11). s′ can be obtained as follows, s′ = min(Ni , Nj) (14) The adjustment of s′ is to avoid p′(i,k) p′(j,k) being 0 or positive infinity, which would be beneficial for calculation. The relative entropy' property is not symmetry, so the following changes are needed to make it symmetrical, rij = Rij(P ′(i)P ′(j)) + Rji(P ′(j)P ′(i)) (15) Thus, rij = rji holds, and the relative entropy between two communities are symmetry. Because the relative entropy measure the difference between two probability set, the difference between two communities are obtained in this situation. The bigger rij, the greater the difference between two communities structure is. So the similarity index is obtained based on relative entropy to show the similarity between two communities, and it is denoted as sij and defined as follows, sij = 1 − (16) rij max(rij) where sij is also symmetry, and shows the similarity between two communities structure. The more similar the two communities, the less the difference between them is, the closer rij is to max(rij) and the closer sij is to zero. So the similarity between two communities structure can be measured by the relative entropy, which can give a novel approach to this problem. The relative entropy focuses on the local structure topological information in the community structure, which is more reasonable. 3.1.3. Edges in the network The number of edges inside and outside the community are also important for community vulnerability measuring. In this section, the number of edges 12 is considered. Definition 3.3. (Number of edges inside the community). The number of edges inside the community ck is donated as Din ck and defined as follows, Din ck =Xi∈ckXj∈ck aij (17) where node i and node j are within the community ck, aij is the element of adjacency matrix A. Thus, aij is entirely inside the community. Definition 3.4. (Number of edges outside the community). The number of edges outside the community ck is donated as Dout ck and defined as follows, Dout ck =Xi∈ckXj /∈ck aij (18) where node i is within the community ck, and node j is outside the community ck, aij is the element of adjacency matrix A. Thus, aij connects the chosen community and other communities which can show the relationship between them. 3.1.4. Community vulnerability measure Lastly, all of the factors defined in Definition 3.1 to 3.4 are considered in the vulnerability measuring model. This proposed method would consider the in- ternal factors and external factors which consider more details of community, and is defined as follows, Definition 3.5. (Proposed community vulnerability measure). The vulnera- bility of community x is donated as V ulx and defined as follows, V ulx = (Sx)α x )β (Dout 1 (Din x )λ(Tx)η 13 (19) where α, β, λ, η are the weight factors of different parameters, and all of them are bigger than zero. Din is the number of edges inside and out- x and Dout x side the community x respectively, Tx is the complexity degree of community x, and Sx represents the similarity degree between community x and other communities (exclude community x itself ) which can be shown as follows, k Sx = sxj, j 6= x (20) where sxj can be obtained by Eq. (16) Xj=1 The relative vulnerability of community x is denoted as RVx and defined as follows, RVx = V ulx V ul , V ul = min y (V uly) (21) In order for these parameters to be considered on the same scale, all of these four parameters sxj, Dout x , Tx are normalized firstly. The weight factors α, β, λ, η can give the weight to consider different parameters, which x , Din can be adjusted in different situation. This setting of weight factor makes this proposed method more reasonable. Some special cases of this proposed method V ulx are shown as follows, 1) When α=β=λ=η, this four parameters are considered equally. 2) When β=1, and α=λ=η=0, this proposed method V ulx would degenerate to the classical vulnerability measure vx in Eq. (6). 3) When α=β= 0, this proposed method V ulx would consider the external factors, which is the communities connected with chosen community. 4) When λ=η=0, this proposed method V ulx would only consider the inter- nal factors, i.e., the chosen community. 14 3.2. Sensitive analysis Because these four weight factors (α, β, λ, η) are important for community vulnerability measuring, and the vulnerability result would have a related changes as weight factors change, thus, how to determine factors has been a problem in this model. In this section, the sensitive of these weight factors are analysed. In general, the global sensitivity analysis ia a useful tool to obtain the influence of inputs on the output variability in mathematical and physical model, and Sobol' indices based on variance decomposition is applied in this paper. The first-order Sobol' index SI(Xi) and total effect index ST (Xi) are defined as follows respectively, SI(Xi) = V arXi(EX∼i(Y Xi )) V ar(Y ) ST (Xi) = EX∼i(V arXi(Y X∼i )) V ar(Y ) (22) (23) where Y represents the output of system, Xi is the ith independent input X, X∼i is all of the inputs exclude Xi, V ar(Y ) is the variance which change with these inputs. The first-order Sobol' index SI(i) can get the contribution of Xi to Y , and total effect index ST (i) can get the contribution to the variance of Y by the variability of each input Xi, which considering its individual effects and the interaction with other variables. Each weight factors are randomly generated 10000 times by Monte Carlo method, and the range fall into [0.2, 5]. The vulnerability result would be obtained by these random factor combinations, and the contribution of different weight factors can be obtained by first-order Sobol' index and total effect index. 15 B 3 4 5 A 1 2 6 C 7 9 8 Fig. 2: An example network with 9 nodes. 3.3. An illustrative example In this section, an example network is given to show the difference between this proposed method V ulx and classical measure vx. The network structure is shown in Fig. 2. Observing from Fig. 2, this network has 9 nodes and 14 edges, and the community structure of network is detected by Newman's modularity in Eq. (4). The network is divided into three communities (Q = 0.2857) and each of the community is a fully-connected subnetwork. All of these four weight factors α, β, λ, η equal to one which make four parameters equally important. According to this proposed method in Eq. (19), (21) and classical measure in Eq. (6), (7), four parameters and the vulnerability of three communities are shown in Table 1. From Table 1 when α=β=λ=η= 1, it can be found that the vulnerability of community C is the lowest, which is the same as the classical measure, but the vulnerability of community A and B is different with classical measure. 16 Table 1: The vulnerability of three communities in example network in Fig. 2. Community Community A Sx 1 Tx 0.5 Din x 0.1667 Dout x 0.5 Vx 0.5 Community B 0.4298 0.7924 Community C 0.8687 1 0.5 1 0.5 0.5 2.1696 2.4975 1 1 0.8687 1 V ulx RVx vx Rx 24 27.6264 2 2 1 2 2 1 It can be found from Table 1 that the classical measure of the vulnerability vx of community A and B is same and it is 2 because of the same num- ber of edges outside of chosen community. However, this classical method is not reasonable, because the vulnerability of one chosen community is de- termined not only by external factors but also by internal factors. From Fig. 2, community A is a fully-connected subnetwork with only two nodes, but community B is a fully-connected subnetwork with three nodes. When the network' structure is similar, i.e., fully-connected, the network with more nodes would be more robust, so community B is more robust than community A. The similar vulnerability result can be obtained by this proposed method (V ulB = 2.1696 < V ulC = 24), which is more reasonable for real-world application. The relative vulnerability RVx can be more obvious to show the vulnerability difference between different community. From the compar- ison result of example network, this proposed vulnerability measure V ulx outperforms classical method, and can distinguish the vulnerability level of community that the classical method cannot distinguish. 4. Experimental study In this section, three real-world complex networks are applied to show the performance and effectiveness of this proposed method. These three net- works are namely as Manzi network [51], Karate network [52], Italian power 17 Table 2: The topological properties of real-world complex networks. Network Manzi Karate n 52 34 m 76 78 2.8077 4.5882 Italian 127 171 2.6929 hki kmax hdi dmax 5 17 7 5.5000 2.4082 8.5682 13 5 25 network [53] respectively. The topological properties of these three networks are shown in Table 2. Observing from Table 2, n and m is the number of hki and kmax is the average and maximum nodes and edges respectively. value of degree respectively, and hdi and dmax is the average and maximum value of shortest distance respectively in the network. 4.1. Manzi network Firstly, the telephone network in Belgium [51] which was analyzed for re- liability purposes is used in this section. The topological structure of this network and the community structure obtained by Newman's modularity [48] is shown in Fig. 3. Observing from Fig. 3, Manzi network is divided into seven communities (Q = 0.6316), and the detail nodes in each community is shown in Table 3. The vulnerability of each community can guide the identification of critical community in the network. The vulnerability V ulx and relative vulnerability RVx of each community are given in Table 4, the classical comparing vul- nerability measure vx and Rx are also shown in Table 4. Observing classical measure Rx in Table 4, community 7 is the most vulnerable community, but community 3 is the most robust community in the network. The vulnerability of the rest of community (community 1, 2, 4, 5, 6) cannot be identified by the classical measure because of the same value of Rx. Thus, this novel method 18 Community 5 Community 7 Community 3 Fig. 3: Manzi et al. network [51]. is proposed based on two parts of information, including internal factors and external factors. The result of this proposed method (V ulx, RVx) are shown in Table 4. It can be found that community 3 is also the most robust com- munity in the network which is same as the classical method. The value of RVx in community 4 and community 7 is close, which are more vulnerable than other communities. The rest of communities can get close but different RVx, which can give a vulnerable order of this community (community 6 > community 5 > community 2 > community 1). The vulnerable order of community in the network is community 4 > community 7 > community 6 > community 5 > community 2 > community 1 > community 3. So this proposed method can consider more information in the network and give a detail vulnerable order for these communities which can overcome some limitations of classical method. 19 Table 3: The community details of Manzi network. community k Nodes in community k 1 2 3 4 5 6 7 3,6,7,8,9,10,13 1,2,4,5,11,12,14 15,16,17,18,20,21,24,25,29,31 19,22,26 23,38,30,32,36,37,41,43 27,33,34,35,38,39,40,42,45,46,47,49,50 44,48,51,52 Table 4: The vulnerability of communities in Manzi network. Community Sx Tx Din x Dout x V ulx RVx vx Rx Vx 0.6667 1 2 3 4 5 6 7 0.3518 0.6864 0.4210 0.6667 1.8260 1.8775 0.3529 0.7909 0.3684 0.6667 0.6667 1.8170 1.8682 0.4783 0.9344 0.5263 1 1 0.9725 1 1 0.5447 0.1578 0.6667 0.6667 17.4406 17.9322 0.4139 0.8814 0.4210 0.6667 0.6667 1.6730 1.7202 0.7654 1 1 0.6667 0.6667 1.1482 1.1805 0.6429 0.5915 0.2105 0.3333 0.3333 15.4872 15.9238 3 20 1.5 1.5 1 1.5 1.5 1.5 1.5 1.5 1 1.5 1.5 1.5 3 Then, Sobol' indices introduced in Section 3.2 is used in this section to anal- ysis the global sensitivity of these four weight factor α, β, λ, η. These weight factors can adjust the consideration of different parameters which can give a different vulnerability result. The sensitivity analysis result for the vulnera- bility of different community with different weight factors are shown in Table 5. Some conclusions can be obtained as follows, 1) The value of first-order Sobol' index can show the sensitivity of different wight factors. For instance, the vulnerability of community 1 is most sensitive to weight factor α, followed by λ, the other two factors β and η are less sensitive. 2) When the parameters of community equals to one, the first-order Sobol' index and total effect index would equal to 1. That is because no matter how weight factor change, the influence parameter would remain the same, i.e., equal to 1. For example, Tx and Din x equal to 1 in community 6, so SI(η), ST (η), SI(λ) and ST (λ) equal to 0. Thus, the variability of these two weight factors would not affect the vulnerability measure of community 6. The same situation can occur in Sx of community 4 and Dout of community 3. x 3) In most of communities, the first-order Sobol' index SI(β) and SI(η) are smaller than SI(α) and SI(λ), which means the vulnerability measure of community is more sensitive with α and λ. The similarity degree and the number of edges within community are more influential to the vulnerability results. 4) The first-order Sobol' index SI(β), SI(λ), SI(η) would be smaller when the value of parameters Tx, Din situation which is bigger with bigger parameters Sx. The situation occurs because V ulx is positively correlated with Sx, but negatively correlated with are bigger, and SI(α) is different x , and Dout x 21 Table 5: The sensitivity analysis results of the vulnerability of communities in Manzi network with different weight factors. Community SI(α) ST (α) SI(β) ST (β) SI(λ) ST (λ) SI(η) ST (η) 1 2 3 4 5 6 7 0.2055 0.7504 0.0529 0.2604 0.1570 0.5644 0.0294 0.2394 0.1983 0.7288 0.0509 0.2655 0.1941 0.6308 0.0114 0.1070 0.3969 0.6861 0 0 0.3116 0.5945 0.0044 0.0124 0 0 0.0253 0.2524 0.4246 0.8596 0.0883 0.4478 0.2229 0.6721 0.0650 0.2812 0.2247 0.6074 0.0048 0.0345 0.2895 0.3756 0.6343 0.7163 0 0 0 0 0.0275 0.3536 0.0966 0.6666 0.1579 0.7105 0.0374 0.3531 x , and Dout Tx, Din x . Hence the value trend of these parameters would have different impact on the vulnerability of communities. These patterns can be observed from all of these communities vulnerability sensitivity analysis in Table 5. 5) The sum of the first-order Sobol' index over these four weight factors in different communities are less than 1, which means there is an interaction between these four parameters. But this situation does not occur in total effect index. 6) Because of the interaction between these parameters, there would be a huge difference between first-order Sobol' index and total effect index. But it is interesting to find that the order of total effect index would be the same as first-order Sobol' index. For instance, the order of first-order Sobol' index in community 1 is SI(η) < SI(β) < SI(λ) < SI(α), the order of total effect index is ST (η) < ST (β) < ST (λ) < ST (α), which is same as previous order. 22 Table 6: The community details of Karate network. community k Nodes in community k 1 2 1, 2, 3, 4, 5, 6, 7, 8, 10, 11, 12, 13, 14, 17, 18, 20, 22 9, 15, 16, 19, 21, 23, 24, 25, 26, 27, 28, 29, 30, 31, 32, 33, 34 Because Sobol' indices is convenient to obtained, and similar results can be obtained from differen network, we only analyse the sensitivity of weight factors in Manzi network and don't analyse the subsequent network. 4.2. Karate network Next, a social network is used in this section to show the performance of this proposed method. This social network is named as Karate club network, which describes the relationship between 34 members of one club in US uni- versity [52]. The topological structure and community structure divided by Newman's modularity is shown in Fig. 4. Every nodes in the network denote a member in karate club, including the instructors and administrators, and the edges in the network represent the relationship between two members beyond their normal activities in the club. The network is divided into two communities (Q = 0.38), and it is same as the well-known community struc- ture result because there has been disagreement between administrators and instructors [52]. The detail member in each communities is shown in Table 6, and it can be found that the members are divided equally and each com- munity have 17 members. The leader in each community is node 1 and node 34 respectively because of their largest degree. The vulnerability measure result of Karate network is shown in Table 7. Be- cause there is only two communities, it can be found that the external factors 23 Community 2 Community 1 Fig. 4: Karate club network [52]. (Sx, Dout x ) are determined by each other, and they are the same. Thus, the classical measure Rx would obtain same result and cannot identify the vul- nerability degree of each community. But the internal factors are determined by community itself, these parameters can get a different result. It is inter- esting to find that the number of edges inside the community Din x is also same and it is 34, but the edges between nodes are different which result in a dif- ferent complexity degree. The complexity degree Tx of two communities are 0.7060 and 1 respectively, which would get a different vulnerability measure for different communities. The relative vulnerability RVx of each communi- ties are 1.4162 and 1 respectively, which can get conclusion that community 1 is more vulnerable than community 2. The main reason for their different vulnerability result is the complexity degree of each community, and the ini- tial reason is the topological structure of each community. From this case, we can find that the vulnerability cannot be distinguished when the number of communities is too small. The topological structure inside the commu- nity is also important for the vulnerability result, and more factors should be considered to make a accurate identification for their vulnerability. So this proposed method can get a reasonable vulnerability comparison result 24 Table 7: The vulnerability of communities in Karate network. Community Sx Tx 1 2 1 1 0.7060 Din x Dout 1 x 1 1 1 1 Vx 1 1 V ulx RVx vx Rx 1.4162 1.4162 1 1 1 1 1 1 in Karate club network, whereas, the classical method Rx can only get the same vulnerability for two communities. 4.3. Italian 380KV power grid Lastly, the Italian 380KV power transmission grid network [53] is used in this section. This network has been frequently used to analyse the network vulnerability performance. The topological structure and community struc- ture is shown in Fig. 5. Observing from Fig. 5, this network is divided into 10 communities (Q = 0.7596), and different communities have different num- ber of components and the detail is shown in Table 8. It can be found that community 9 and community 7 have the maximum and minimum number of components respectively. The vulnerability results are shown in Table 9. In this network, a novel method which is proposed by Wei et al. [30] is used as a comparing method, this method is also modified from Ref [29]. The detail parameters and vul- nerability results of communities are shown in Table 9. Observing from Table 9, community 5 is the most robust community from RVx and Rx, but R′ x give a result that community 7 is the most robust. Community 7 only have 6 nodes which is the minimum number of nodes, so this conclusion (com- munity 7 is the most robust) have low credibility, and it can be also seen from these four parameters (Sx, Tx, Din x ) in Table 9. Community 10 is consider to be the most vulnerable from these three methods at the same x , Dout 25 Fig. 5: Italian 380KV power grid network [53]. Table 8: The community details of Italian 380KV power network. community k Nodes in community k 1 2 3 4 5 6 7 8 9 1, 2, 3, 4, 5, 6, 7, 8, 9, 11, 12, 13, 20, 19 37, 38, 36, 39, 35, 32, 60, 33, 31, 30, 34, 42 57, 56, 52, 49, 50, 47, 46, 45, 43, 44, 51, 54, 55 10, 16, 15, 17, 18, 21, 22, 24, 26, 25, 28, 29, 27, 23, 59, 58 61, 62, 63, 64, 65, 67, 71, 40, 41, 66, 68, 70, 53, 48, 69 77, 78, 81, 74, 75, 79, 82, 76, 72, 14, 73 83, 84, 85, 86, 101, 100 102, 110, 111, 115, 120, 113, 117, 118, 116, 114, 112 119, 109, 107, 108, 106, 104, 103, 105, 97, 99, 98, 88, 87, 96, 91, 95, 80, 92, 90, 93, 94, 89 10 122, 123, 121, 126, 125, 124, 127 26 time. This proposed method would magnify the vulnerability of community, like the relative vulnerability of propose method RVx = 43.8623 and other method Rx = 8, R′ x = 11.4347. The RVx of most vulnerable community would be much bigger than other methods, which is convenient to find the vulnerability of community. Meanwhile, the classical method cannot identify some communities' vulnerability, such as community 2, 4, 6 and commu- nity 1, 3, 7, 8, because of the same Rx. This proposed method and Wei et al. method can get a certain vulnerability order for these communities (2, 4, 6 and 1, 3, 7, 8). The detail vulnerability orders of these communities obtained by different methods are shown in Table 10. From these orders, it can be found that the order obtained by this proposed method is more similar with classical method than Wei method. Specifically, community 9 is considered as the second to last vulnerable community in classical method and proposed method, but it is considered as second vulnerable community by Wei method. Community 3, 7, 8 is considered as the second vulnerable community by classical method at the same time, and this proposed method give a conclusion that community 7, 8, 3 is the second, third, forth vulnera- ble community respectively which is similar with classical method, but Wei method gives a dissimilar order. Other more detail information about the vulnerability order of communities can be obtained from Table 10. So this proposed method would consider more information of community and give a certain vulnerability order, and is more reasonable than other methods. 5. Conclusion The vulnerability measuring of community has already been a hot topic in the study of network theory. In this paper, a new entropy-based method is proposed to measure the vulnerability of communities which can over- 27 Table 9: The vulnerability of communities in Italian 380KV power network. Community Sx Tx Din x Dout x 0.3469 0.9205 0.5161 0.3750 Vx 0.3750 V ulx RVx vx Rx 1.9470 1.9444 2.6667 2.6667 v′ x [30] R′ 9.1020 x [30] 2.6547 0.4055 0.7882 0.4193 0.6250 0.6250 1.9629 1.9603 1.6000 1.6000 5.0539 1.4741 0.4675 0.8954 0.4838 0.3750 0.3750 2.8773 2.8734 2.6667 2.6667 6.9333 2.0222 0.5951 0.8733 0.6129 0.6250 0.6250 1.7789 1.7765 1.6000 1.6000 5.6606 1.651 0.4661 0.8017 0.5806 1 1 1.0013 1 1 1 4.0843 1.1912 0.4017 0.7588 0.4193 0.6250 0.6250 2.0198 2.0171 1.6000 1.6000 3.4459 1.005 1 0.4891 0.2258 0.3750 0.3750 24.1426 24.1102 2.6667 2.6667 3.4286 1 0.4114 0.8543 0.3870 0.3750 0.3750 3.3173 3.3128 2.6667 2.6667 8.5554 2.4953 0.7848 1 1 0.7500 0.7500 1.0465 1.0451 1.3333 1.3333 9.5387 2.7821 1 2 3 4 5 6 7 8 9 10 0.7305 0.6875 0.1935 0.1250 0.1250 43.9213 43.8623 8 8 39.2052 11.4347 Table 10: The vulnerability order of Italian 380KV power network by different method. Method Vulnerability order Classical [29] Community 5 < 9 < 2 = 4 = 6 < 1 = 3 = 7 = 8 < 10 Proposed Community 5 < 9 < 4 < 1 < 2 < 6 < 3 < 8 < 7 < 10 Wei et al. [30] Community 7 < 6 < 5 < 2 < 4 < 3 < 8 < 1 < 9 < 10 28 come the shortcomings and limitations of previous methods. Different with previous method, this proposed method combines the internal factors and external factors of community which give sufficient consideration of commu- nity information. Thus, reasonable vulnerability result can be obtained by this proposed method. The internal factors contain the number of edges inside community and the complexity degree of community measured by Tsallis structure entropy, and the external factors contain the number of edges outside community and the similarity degree between chosen commu- nity and other communities measured by relative entropy. The vulnerability and relative vulnerability of community are obtained to give the quantitative description of vulnerability of community eventually. In order to show the performance and effectiveness of this proposed method, one example network and three real-world complex network are applied. Through the vulnerabil- ity order obtained by different methods, the rationality of this method is demonstrated. In addition, the sensitivity of weight factors are analysed by Sobol' indices, the important parameters considered in this model can be obtained. The experiment results show the superiority and reasonableness of this propose method. Acknowledgment The authors thank Prof. Claudio Rocco for providing us with some network data. The work is partially supported by National Natural Science Founda- tion of China (Grant Nos. 61573290, 61503237). 29 Reference References [1] X. Guan, Z. Xu, and Q. S. Jia, "Energy-efficient buildings facilitated by microgrid," Ieee Transactions on Smart Grid, vol. 1, no. 3, pp. 243 -- 252, 2010. [2] D. Bruneo, S. Distefano, M. Giacobbe, A. L. Minnolo, F. Longo, G. Mer- lino, D. Mulfari, A. Panarello, G. Patan, A. Puliafito, C. Puliafito, and N. Tapas, "An iot service ecosystem for smart cities: The smartme project," Internet of Things, vol. 5, pp. 12 -- 33, 2019. [3] R. Dautov, S. Distefano, and R. Buyya, "Hierarchical data fusion for smart healthcare," Journal of Big Data, vol. 6, no. 1, p. 19, 2019. [4] R. Dautov, S. Distefano, D. Bruneo, F. Longo, G. Merlino, A. Puliafito, and R. Buyya, "Metropolitan intelligent surveillance systems for ur- ban areas by harnessing iot and edge computing paradigms," Software: Practice and Experience, vol. 48, no. 8, pp. 1475 -- 1492, 2018. [5] L. Lee and P. Hu, "Vulnerability analysis of cascading dynamics in smart grids under load redistribution attacks," International Journal of Elec- trical Power & Energy Systems, vol. 111, pp. 182 -- 190, 2019. [6] L. F. Cheng and T. Yu, "Smart dispatching for energy internet with complex cyber-physical-social systems: A parallel dispatch perspective," International Journal of Energy Research, vol. 43, no. 8, pp. 3080 -- 3133, 2019. [7] H. Guo, S. S. Yu, H. H. C. Iu, T. Fernando, and C. Zheng, "A complex network theory analytical approach to power system cascading failure- 30 from a cyber-physical perspective," Chaos: An Interdisciplinary Journal of Nonlinear Science, vol. 29, no. 5, p. 053111, 2019. [8] Z. Wang, M. Jusup, L. Shi, J. H. Lee, Y. Iwasa, and S. Boccaletti, "Exploiting a cognitive bias promotes cooperation in social dilemma experiments," Nature communications, vol. 9, no. 1, p. 2954, 2018. [9] Z. Wang, M. Jusup, R. W. Wang, L. Shi, Y. Iwasa, Y. Moreno, and J. Kurths, "Onymity promotes cooperation in social dilemma experi- ments," Science Advances, vol. 3, no. 3, p. e1601444, 2017. [10] L. Ma, J. Li, Q. Lin, M. Gong, C. A. Coello Coello, and Z. Ming, "Reliable link inference for network data with community structures," IEEE Transactions on Cybernetics, vol. 49, no. 9, pp. 3347 -- 3361, 2019. [11] W. Zhang, J. Yang, X. yu Ding, X. mei Zou, H. yu Han, and Q. chao Zhao, "Groups make nodes powerful: Identifying influential nodes in social networks based on social conformity theory and community fea- tures," Expert Systems with Applications, vol. 125, pp. 249 -- 258, 2019. [12] T. Wen and W. Jiang, "Identifying influential nodes based on fuzzy local dimension in complex networks," Chaos, Solitons & Fractals, vol. 119, pp. 332 -- 342, 2019. [13] H. Dui, S. Li, L. Xing, and H. Liu, "System performance-based joint importance analysis guided maintenance for repairable systems," Relia- bility Engineering & System Safety, vol. 186, pp. 162 -- 175, 2019. [14] G. Levitin, L. Xing, and H. Z. Huang, "Optimization of partial software rejuvenation policy," Reliability Engineering & System Safety, vol. 188, pp. 289 -- 296, 2019. 31 [15] G. Levitin, L. Xing, H. B. Haim, and H. Z. Huang, "Dynamic demand satisfaction probability of consecutive sliding window systems with warm standby components," Reliability Engineering & System Safety, vol. 189, pp. 397 -- 405, 2019. [16] G. Levitin, L. Xing, and L. Luo, "Joint optimal checkpointing and reju- venation policy for real-time computing tasks," Reliability Engineering & System Safety, vol. 182, pp. 63 -- 72, 2019. [17] P. Zhu, X. Dai, X. Li, C. Gao, M. Jusup, and Z. Wang, "Community detection in temporal networks via a spreading process," EPL (Euro- physics Letters), vol. 126, no. 4, p. 48001, 2019. [18] G. K. Orman, V. Labatut, M. Plantevit, and J. F. Boulicaut, "Inter- preting communities based on the evolution of a dynamic attributed network," Social Network Analysis and Mining, vol. 5, no. 1, p. 20, 2015. [19] C. M. Rocco, J. Moronta, J. E. Ramirez-Marquez, and K. Barker, "Ef- fects of multi-state links in network community detection," Reliability Engineering & System Safety, vol. 163, pp. 46 -- 56, 2017. [20] G. K. Orman, O. Karadeli, and E. C¸ aliS¸r, "Overlapping communi- ties via k-connected ego centered groups," in Proceedings of the 2015 IEEE/ACM International Conference on Advances in Social Networks Analysis and Mining 2015, ASONAM '15, (New York, NY, USA), pp. 1598 -- 1599, ACM, 2015. [21] G. K. Orman, V. Labatut, and A. T. Naskali, "Exploring the evolution of node neighborhoods in dynamic networks," Physica A: Statistical Me- chanics and its Applications, vol. 482, pp. 375 -- 391, 2017. 32 [22] J. E. Ramirez-Marquez, C. M. Rocco, K. Barker, and J. Moronta, "Quantifying the resilience of community structures in networks," Reli- ability Engineering & System Safety, vol. 169, pp. 466 -- 474, 2018. [23] X. Zhang, S. Mahadevan, S. Sankararaman, and K. Goebel, "Resilience- based network design under uncertainty," Reliability Engineering & Sys- tem Safety, vol. 169, pp. 364 -- 379, 2018. [24] R. Cerqueti, G. Ferraro, and A. Iovanella, "Measuring network resilience through connection patterns," Reliability Engineering & System Safety, vol. 188, pp. 320 -- 329, 2019. [25] X. Zhang, S. Mahadevan, and K. Goebel, "Network reconfiguration for increasing transportation system resilience under extreme events," Risk analysis : an official publication of the Society for Risk Analysis, 2019. [26] J. E. Ramirez-Marquez, C. M. Rocco, J. Moronta, and D. Gama Dessavre, "Robustness in network community detection under links weights uncertainties," Reliability Engineering & System Safety, vol. 153, pp. 88 -- 95, 2016. [27] X. Zhang, S. Mahadevan, and X. Deng, "Reliability analysis with lin- guistic data: An evidential network approach," Reliability Engineering & System Safety, vol. 162, pp. 111 -- 121, 2017. [28] T. Wen, M. X. Song, and W. Jiang, "Evaluating topological vulnera- bility based on fuzzy fractal dimension," International Journal of Fuzzy Systems, vol. 20, no. 6, pp. 1956 -- 1967, 2018. [29] C. M. Rocco S and J. E. Ramirez-Marquez, "Vulnerability metrics and analysis for communities in complex networks," Reliability Engineering & System Safety, vol. 96, no. 10, pp. 1360 -- 1366, 2011. 33 [30] D. Wei, X. Zhang, and S. Mahadevan, "Measuring the vulnerability of community structure in complex networks," Reliability Engineering & System Safety, vol. 174, pp. 41 -- 52, 2018. [31] A. Kovacs-Hostyanszki, R. Foldesi, A. Baldi, A. Endredi, and F. Jordan, "The vulnerability of plant-pollinator communities to honeybee decline: A comparative network analysis in different habitat types," Ecological Indicators, vol. 97, pp. 35 -- 50, 2019. [32] M. A. Alim, X. Li, N. P. Nguyen, M. T. Thai, and A. Helal, "Structural vulnerability assessment of community-based routing in opportunistic networks," Ieee Transactions on Mobile Computing, vol. 15, no. 12, pp. 3156 -- 3170, 2016. [33] Y. Che, J. Jia, Y. Zhao, D. He, and T. Cao, "Vulnerability assessment of urban power grid based on combination evaluation," Safety Science, vol. 113, pp. 144 -- 153, 2019. [34] Y. Wu, Z. Chen, K. Yao, X. Zhao, and Y. Chen, "On the correlation be- tween fractal dimension and robustness ofcomplex networks," Fractals, p. 1950067. [35] W. Deng and Y. Deng, "Entropic methodology for entanglement mea- sures," Physica A: Statistical Mechanics and its Applications, vol. 512, pp. 693 -- 697, 2018. [36] Z. Wang, C. T. Bauch, S. Bhattacharyya, A. d'Onofrio, P. Manfredi, M. Perc, N. Perra, M. Salath´e, and D. Zhao, "Statistical physics of vaccination," Physics Reports, vol. 664, pp. 1 -- 113, 2016. [37] B. Wei and Y. Deng, "A cluster-growing dimension of complex networks: From the view of node closeness centrality," Physica A: Statistical Me- chanics & Its Applications, vol. 522, pp. 80 -- 87, 2019. 34 [38] Y. Wu, K. Yao, and X. Zhang, "The hadamard fractional calculus of a fractal function," Fractals, vol. 26, no. 03, p. 1850025, 2018. [39] T. Wen and W. Jiang, "An information dimension of weighted com- plex networks," Physica A-Statistical Mechanics and Its Applications, vol. 501, pp. 388 -- 399, 2018. [40] W. Jiang, "A correlation coefficient for belief functions," International Journal of Approximate Reasoning, vol. 103, pp. 94 -- 106, 2018. [41] W. Jiang, Y. Cao, and X. Deng, "A Novel Z-network Model Based on Bayesian Network and Z-number," IEEE Transactions on Fuzzy Sys- tems, 2019, doi: 10.1109/TFUZZ.2019.2918999. [42] M. Li, Q. Zhang, and Y. Deng, "Evidential identification of influential nodes in network of networks," Chaos, Solitons & Fractals, vol. 117, pp. 283 -- 296, 2018. [43] Y. Wang, S. Wang, and Y. Deng, "A modified efficiency centrality to identify influential nodes in weighted networks," Pramana, vol. 92, no. 4, p. 68, 2019. [44] P. Xu, R. Zhang, and Y. Deng, "A novel visibility graph transforma- tion of time series into weighted networks," Chaos, Solitons & Fractals, vol. 117, pp. 201 -- 208, 2018. [45] L. Fan and Y. Deng, "A fast algorithm for network forecasting time series," IEEE Access, p. doi: 10.1109/ACCESS.2019.2926986, 2019. [46] T. Wen, S. Duan, and W. Jiang, "Node similarity measuring in complex networks with relative entropy," Communications in Nonlinear Science and Numerical Simulation, vol. 78, p. 104867, 2019. 35 [47] T. Wen and W. Jiang, "Measuring the complexity of complex network by Tsallis entropy," Physica A-Statistical Mechanics and Its Applications, vol. 526, p. 121054, 2019. [48] M. E. J. Newman, "Fast algorithm for detecting community structure in networks," Physical Review E, vol. 69, no. 6, p. 5, 2004. [49] M. E. J. Newman and M. Girvan, "Finding and evaluating community structure in networks," Physical Review E, vol. 69, no. 2, 2004. [50] S. Kullback and R. A. Leibler, "On information and sufficiency," Annals of Mathematical Statistics, vol. 22, no. 1, pp. 79 -- 86, 1951. [51] E. Manzi, M. Labbe, G. Latouche, and F. Maffioli, "Fishman's sampling plan for computing network reliability," Ieee Transactions on Reliability, vol. 50, no. 1, pp. 41 -- 46, 2001. [52] W. W. Zachary, "An information flow model for conflict and fission in small groups," Journal of Anthropological Research, vol. 33, no. 4, pp. 452 -- 473, 1977. [53] P. Crucitti, V. Latora, and M. Marchiori, "Locating critical lines in high- voltage electrical power grids," Fluctuation and Noise Letters, vol. 5, no. 2, pp. L201 -- L208, 2005. 36
1306.4363
1
1306
2013-06-18T21:36:55
Social Network Dynamics in a Massive Online Game: Network Turnover, Non-densification, and Team Engagement in Halo Reach
[ "cs.SI", "physics.data-an", "physics.soc-ph" ]
Online multiplayer games are a popular form of social interaction, used by hundreds of millions of individuals. However, little is known about the social networks within these online games, or how they evolve over time. Understanding human social dynamics within massive online games can shed new light on social interactions in general and inform the development of more engaging systems. Here, we study a novel, large friendship network, inferred from nearly 18 billion social interactions over 44 weeks between 17 million individuals in the popular online game Halo: Reach. This network is one of the largest, most detailed temporal interaction networks studied to date, and provides a novel perspective on the dynamics of online friendship networks, as opposed to mere interaction graphs. Initially, this network exhibits strong structural turnover and decays rapidly from a peak size. In the following period, however, both network size and turnover stabilize, producing a dynamic structural equilibrium. In contrast to other studies, we find that the Halo friendship network is non-densifying: both the mean degree and the average pairwise distance are stable, suggesting that densification cannot occur when maintaining friendships is costly. Finally, players with greater long-term engagement exhibit stronger local clustering, suggesting a group-level social engagement process. These results demonstrate the utility of online games for studying social networks, shed new light on empirical temporal graph patterns, and clarify the claims of universality of network densification.
cs.SI
cs
Social Network Dynamics in a Massive Online Game: Network Turnover, Non-densification, and Team Engagement in Halo Reach 3 1 0 2 n u J 8 1 ] I S . s c [ 1 v 3 6 3 4 . 6 0 3 1 : v i X r a Sears Merritt University of Colorado Boulder [email protected] ABSTRACT Online multiplayer games are a popular form of social inter- action, used by hundreds of millions of individuals. However, little is known about the social networks within these online games, or how they evolve over time. Understanding hu- man social dynamics within massive online games can shed new light on social interactions in general and inform the development of more engaging systems. Here, we study a novel, large friendship network, inferred from nearly 18 bil- lion social interactions over 44 weeks between 17 million in- dividuals in the popular online game Halo: Reach. This net- work is one of the largest, most detailed temporal interaction networks studied to date, and provides a novel perspective on the dynamics of online friendship networks, as opposed to mere interaction graphs. Initially, this network exhibits strong structural turnover and decays rapidly from a peak size. In the following period, however, both network size and turnover stabilize, producing a dynamic structural equilib- rium. In contrast to other studies, we find that the Halo friendship network is non-densifying: both the mean degree and the average pairwise distance are stable, suggesting that densification cannot occur when maintaining friendships is costly. Finally, players with greater long-term engagement exhibit stronger local clustering, suggesting a group-level so- cial engagement process. These results demonstrate the util- ity of online games for studying social networks, shed new light on empirical temporal graph patterns, and clarify the claims of universality of network densification. Categories and Subject Descriptors H.2.8 [Database Applications]: Data Mining General Terms Experimentation, Measurement Keywords graph mining, graph evolution, social networks, friendship inference, temporal data Aaron Clauset University of Colorado Boulder Santa Fe Institute [email protected] INTRODUCTION 1. Although social networks are inherently dynamic, relatively few studies have analyzed the dynamical patterns observed in large, real-world, online social networks. Insights into the basic organizing principles and patterns of these networks should inform the development of probabilistic models of their evolution, the development of novel methods for de- tecting anomalous dynamics, as well as the design of novel, or augmentation of existing, online social systems so as to support better user engagement. Here, we present a brief empirical analysis of a novel online social network, and use its dynamics as a lens by which to both identify interest- ing empirical patterns and test existing claims about social network dynamics. This network is drawn from a massive online game Halo: Reach, which includes the activities of 17 million unique in- dividuals across roughly 2,700,000 person-years of continu- ous online interaction time. Multiplayer games like these are a highly popular form of online interaction, and yet, likely due to the lack of data availability, have rarely been stud- ied in the context of online social networks. As a result, we know more about networks like Facebook and Twitter, which consume relatively little time per user per week, than we do about more immersive online social systems like multi- player games, which consume on average more than 20 hours of time per user per week [9]. Furthermore, online games represent a large economic sec- tor, including not just the sale of the software itself, but an entire ecosystem of entertainment products, worth billions of US dollars worldwide. For example, on the first day of sale Halo: Reach grossed nearly $200 million in revenue from roughly 4 million copies of the game. Increasingly, one point of attraction to this and other online games is their multi- player component: while it is possible to play individually, the online system is designed to encourage and reward social play. Despite their enormous popularity, relatively little is known about the social networks within these online games, how they evolve over time, and whether the patterns they exhibit agree or disagree with what we know about online social interactions from other online systems. This raises two interesting questions. First, what is the shape of a social network in a massive, multiplayer online game? And second, how does this network change over time? Answers to these questions will shed new light on the rel- ative importance of a game’s social dimension and on the relationship between a game’s social structure and its long term success, and will clarify the generality of our current be- liefs about online social networks, which are largely derived from non-game systems like Facebook, Twitter, Flickr, etc. One immediate difference between the social network under- lying online games and those more classically studied is the competitive nature of games. The large scale of and rich data produced by online games provides a novel perspective on certain other social interactions, e.g., team competition. Past work has shed light on competitive dynamics [22], social organization [33], economic trading networks [17], and de- viant behavior [5]. Here, we study the underlying friendship network from Halo:Reach, which we infer [23] from 18 billion interactions between 17 million individuals over the course of 44 weeks. Edges in this network represent inferred online or offline friendships, in contrast to mere online interactions alone, which the Halo system generates randomly via the matchmaking system that places players into competitions. We first analyze the static (cumulative) friendship network and find that it contains a heavy-tailed degree distribution, which appears more log-normal than power law. This net- work is composed of many small disconnected components and a single giant component containing roughly 30% of all players. A plurality of vertices exhibit low clustering coeffi- cients (0 < ci ≤ 0.1), indicating very sparse local structure, while the next-most-common pattern is to exhibit a very high clustering coefficient (0.9 < ci < 1.0), indicating very dense local structure. To study the friendship network’s evolution we create a time series of 44 network snapshots, one for each week of the year. Initially, this network exhibit strong structural turnover and decays rapidly from a peak size to a more stable, but dy- namic core. Despite its apparently stable size, we find steady network turnover over most of the time period, indicating a dynamic equilibrium as roughly equal numbers of vertices join and leave the network each week. Furthermore, in con- trast to other online social networks [18], the Halo friendship network does not densify over time: the mean degree and the average pairwise distance within the giant component are stable. Finally, we observe that the network’s clustering grows over the first 25 weeks and then declines, suggesting that players form increasingly tight knit groups during the first half of the network’s life only to disband them later. In addition, we find a positive relationship between the consecutive weeks played and the player’s mean clustering coefficient. This indicates that players who belong to tightly knit groups tend to also play longer and more consistently. 2. RELATED WORK Work related to the analysis of networks began with the study of static networks. Researchers identified important structural patterns such as heavy tailed degree distribu- tions [4], small-world phenomenon [24, 35], and commu- nities, as well as probabilistic models and algorithms that produce and detect them [26, 8]. As new online social systems continue to emerge on the web, the static analysis of social networks continues to be an area of great interest. Researchers have a steady stream of new empirical network data with which they can test new and ex- isting theories about social dynamics, whose sources include Twitter [19], Facebook [34], Orkut and Flicker [25]. More recently, researchers have begun to study how time influences [7] and changes network structure [2]. New dy- namical patterns, such as densification [20, 18] and shrink- ing k-cores [11], as well as probabilistic models have been identified that shed light on how changes in the underlying processes that produce these networks affect its structure. Since the underlying processes that produce complex net- works are typically not random, a rich body of work related to mathematically modeling various networks whose struc- ture cannot be generated by an Erdos-R´enyi random graph model has emerged [10]. One such model is the configura- tion model, which produces a graph with a predefined de- gree distribution by randomly assigning edges between ver- tices according to their degree sequence [28]. Another is the preferential attachment model, which is a generative model that produces heavy tailed degree distributions by assign- ing edges to vertices according to the notion of “the rich get richer”. That is, edges are assigned to vertices according to how many they already have. Other approaches that pro- duce specific properties, such as short diameters and commu- nities include the Watts and Strogatz model and stochastic block model respectively [35, 12]. Lastly, we would be remiss if we did not also mention work related to the study of online games. Most uses of online game data have focused on understanding certain aspects of human social behavior in online environments. Examples include individual and team performance [30, 31, 32, 29], ex- pert behavior [16, 13], homophily [14], group formation [15], economic activity [6, 3], and deviant behavior [1]. Most of this work has focused on massively multiplayer online role playing games (MMORPGs), e.g., World of Warcraft, al- though a few have examined social behavior in first person shooter (FPS) games like Reach [32]. Relatively little of this work has focused on the structure and dynamics of social networks. The remainder of this paper is organized as follows: first we discuss related work. Next, for completeness, we introduce the data and the results of an anonymous online survey. Fol- lowing this, we briefly describe the method used to infer the social network. These topics are described in detail in [23]. Following this, we analyze the inferred social network stati- cally and then dynamically. We conclude with a discussion and final thoughts on future work. A particularly unique aspect of our work is our data set. Few studies have analyzed the temporal dynamics of a social network derived from a popular form of social media, online games. Moreover, the majority of studies that examine the temporal dynamics of networks only analyze networks that primarily grow over time. That is, once a vertex is added to these networks it is never removed. In our network, vertices enter and leave the network consistently over time. ) s n o i l l i i i m n i ( s l a u d v d n i e u q n u l a t o T i 5.0 4.5 4.0 3.5 3.0 2.5 2.0 1.5 1.0 0.5 k t s a e l t a e e r g e d h t i w s e c i t r e v f o n o i t c a r F 100 10-1 10-2 10-3 10-4 10-5 10-6 100 Sunday Monday Tuesday Wednesday Thursday Friday Saturday 3am 6am 9am 12pm 3pm 6pm 9pm 12am Hour of day (PST) Tail undersampled Tail oversampled 101 Degree, k 102 103 Figure 1: (Top) Number of unique individuals ever seen at a given time of day (in Pacific Standard Time), across the 305 days spanned by the data, illustrating significant daily and weekly periodici- ties. (Bottom) Complementary cumulative distri- bution functions of vertex degrees 3. DATA AND SURVEY 3.1 Game details Our data are derived from detailed records of game play from Halo: Reach, a popular online first person shooter game. In- dividual game files were made available through the Halo Reach Stats API.1 Through this interface, we collected the first 700 million game instances (roughly 305 days of activ- ity by 17 million individuals). Among other information, each game file includes a Unix timestamp, game type la- bel, and a list of gamertags. This large database provides us with complete data on the timing and character of in- teractions between individuals but provides no information about which interactions are produced by friendships versus non-friendships. 1The API was active from September 2010 through Novem- ber 2012. API documentation was taken offline in Septem- ber 2012. 3.2 Survey We combine these in-game behavioral data with the results of an anonymous online survey of Reach players [21]. In the survey, participants supplied their gamertag from which we generated a list of all other gamertags that had ever appeared in a game with the participant. From this list, the participant identified which individuals were friends. 2 We interpret these subjective friendship labels as ground truth. From these data, we constructed a social network with links pointing from participants to their labeled friends. In our supervised learning analysis, both a labeled friendship and the absence of a label are treated as values to be predicted (i.e., we assume survey respondents explicitly chose not to label their co-player as a friend). Of the 965 participants who had completed the friendship portion of the survey by April 2012, 847 individuals appear in our data (the first 305 days of play); this yielded 14,045 latent friendship ties and 7,159,989 non-friendship ties. 3.3 Interaction network We represent the set of pairwise interactions as a temporal network, in which edges have endpoints and exist at a spe- cific moment in time. Vertices in the network correspond to gamertags, and two vertices are connected if they appear in a game instance together at time t (time of day, in 10 minute intervals). Each vertex thus has a sequence or time series of interactions with other vertices. The resulting network, de- rived from our complete game sample, contains 17,286,270 vertices, 18,305,874,864 temporal edges, and spans 305 days. The subgraph of interactions by our survey participants con- tained a total of 2,531,479 vertices and 665,401,283 temporal edges over the same period of time. INFERRING THE SOCIAL NETWORK 4. Pairs of individuals in Reach that are friends are known to play many more consecutive games (12, on average, or about 2 hours of time) than non-friends (1.25, on average) [21]. Thus, continuous interaction over a significant span of time is likely an indication of a latent tie, while more intermittent interactions likely indicate a non-friend tie, given the large population of non-friends available to play at any time. The expected diurnal and weekly cycles observed in the data will modulate these behaviors, and a reasonable approach for their quantification is via interaction periodicity (see Fig. 1, top). Let nx,y(t) = 1{x and y play together at time t} (1) represent the time series of binary interactions between in- dividuals x and y, where 1 indicates an interaction at time t and 0 indicates no interaction. If x and y are friends, we expect nx,y(t) to exhibit stronger periodicity than for non-friends. This expectation may be quantified as the au- tocorrelation of the time series nx,y(t) over all time lags τ : ACx,y = X X nx,y(t)nx,y(t − τ ). (2) τ t If nx,y(t) is generated by a non-friend pair, ACx,y should be small because these individuals do not interact regularly. On the other hand, if nx,y(t) is generated by a friend pair, we expect ACx,y to be large. Training a logistic regression 2In the survey, a friend is defined as a person known by the respondent at least casually, either offline or online. 5.0 4.0 3.0 2.0 1.0 ) s n o i l l i m ( s e d o n f o r e b m u N 0.0 0.1 0.2 Tail oversampled Tail undersampled 100 10-1 10-2 ) s = S ( r P 10-3 10-4 10-5 10-6 Tail oversampled Tail undersampled Tail oversampled Tail undersampled 5 4 3 2 1 ) s n o i l l i m ( s e c i t r e v l a t o T 106 107 0 0 5 10 15 ← Week of Jan. 1st 20 25 Week, w 30 35 40 45 0.4 0.3 0.8 Clustering coefficient, Ci 0.5 0.6 0.7 0.9 1.0 10-7 100 101 103 105 102 Component size, s 104 Figure 2: (Left) Histogram of vertex level clustering coefficients, Ci (Center) Distribution of component sizes. (Right) Total number of vertices in the network as a function of week, w. All figures plot distributions for networks using under and over sampled tail thresholds (ACx,y = 197 and ACx,y = 1900 respectively) classifier on this feature alone correctly identifies 95% of ties, even for casual users (i.e. those that play few games). For a detailed presentation of this analysis, see [23]. efficient equal to one indicates the vertex and its neighbors form a clique, while a coefficient equal to zero indicates none of the vertex’s neighbors are connected. The survey respondents are a biased sample of Reach play- ers [21], being substantially more skilled than the typical player and investing roughly an order of magnitude more time playing than an average player. It is thus possible that the survey sampling bias has produced an oversampling or an undersampling of the tail of the degree distribution. In an attempt to control these opposing biases, we choose two thresholds, one to show what the network looks like if the survey respondents have less friends (undersampled tail) than the population, where ACx,y = 197, and one to show network structure if the respondents have more (oversam- pled tail), ACx,y = 1900. Details of the methods used to select these thresholds can be found in [23]. 5. NETWORK STRUCTURE The two thresholds computed using the survey data in the previous section represent reasonable bounds on what we ex- pect to observe in the data at large. In this section, we use both thresholds to analyze the structure of the inferred so- cial network and show that network structure remains invari- ant to threshold choice. In the undersampled tail scenario (ACx,y = 197), the inferred network consists of 8,373,201 nodes and 31,051,991 edges, while the network inferred us- ing the oversampled tail threshold (ACx,y = 1900), contains 4,732,405 nodes and 11,435,351 edges. Figure 1(bottom) plots the complementary cumulative dis- tribution of vertex degree sizes and indicates that the net- work is primarily comprised of vertices with only a few edges and only 10% containing more than roughly 10 or 20, de- pending on threshold choice. To quantitatively measure the degree to which groups make up the network, we compute the vertex level clustering co- efficient, defined as, Ci = number of connected neighbors number of possible connected neighbors . (3) Ci provides a principled measure of how close vertex i and its neighbors are to forming a clique [27]. A clustering co- In addition to vertices containing only a few edges, the majority possess low clustering coefficients, indicating that most players usually choose to play games with only one other person at a time (see Fig. 2, left). There is also a small, but non-trivial group of players who have high clus- tering coefficients, indicating that they choose to play with two or more friends, who are also friends themselves. Figure 2(center) plots the distribution of component sizes and indicates that the network contains a single large con- nected component composed of between two and four mil- lion players. The majority of the remaining nodes are spread amongst many components containing between roughly ten and twenty nodes. In the undersampled tail case (ACx,y = 197), the network contains 1,194,032 components. While in the oversampled tail case (ACx,y = 1900), the network contains 991,932 components. From this analysis, we can conclude that the network, as a whole, contains between 23%-47% of the total 17 million player population and that these players tend to interact with their friends in pairs or small densely connected groups. 6. NETWORK DYNAMICS The static analysis in the previous section sheds light on the overall structure of the social network and provides clues about how friends interact in the game, but it provides no insight into how the network changes over the course of its 44 week time span. To study the friendship network’s evolution, we create snap- shots of the network by extracting the edges of inferred friends from the interaction network at weekly time inter- vals, where each interval is aligned with a week of the year. The set of snapshots we study begins on the 37th week of September, 2010, and extends through the week 28th week of 2011, totaling 44 weeks of time. l s r e y a p d e v r e s b o f o . c a r f e v i t a u m u C l 1.0 0.8 0.6 0.4 0.2 0.0 0 5 10 15 25 20 Week, w Tail oversampled Tail undersampled 30 35 40 45 l w r e t f a r o n o y a p t a h t s r e y a p f o . c a r F l Tail oversampled Tail undersampled 1.0 0.8 0.6 0.4 0.2 0.0 0 5 10 15 25 20 Week ,w 30 35 40 45 ) s n o i l l i m ( s e g d E 8 7 6 5 4 3 2 1 0 0.0 100 80 60 40 20 0 0 Tail oversampled y=cx 0.5 1.0 1.5 2.0 2.5 3.0 3.5 Tail undersampled y=cx 1 2 3 Vertices (millions) 4 5 e e r g e d n a e M 4.0 3.5 3.0 2.5 2.0 1.5 0 40 35 30 25 20 15 10 0 5 10 15 20 25 30 35 40 45 Tail oversampled Global mean 5 10 15 25 20 Week, w Tail undersampled Global mean 30 35 40 45 Figure 3: (Left) Cumulative fraction of observed players per week, w. (Left-Center) Fraction of players in week w that play on or after week w. (Right-Center) Number of edges as a function vertices and linear fit (oversampled tail r2 = 0.99, c = 2.188, p ≪ 0.001, undersampled tail, r2 = 0.98, c = 16.389, p ≪ 0.001), indicating that the network is not densifying. (Right) Mean degree as a function of week, w 6.1 Players In this section, we study how the network’s population evolves over time. Figure 2(right) plots the inferred number of play- ers in the social network, under both thresholds, over each week in the data. On launch week, we observe a small pop- ulation that quickly grows to a peak of roughly 3.25 million and then decreases linearly to roughly 1.3 million. This pat- tern suggests that gamers initially play the game alone, then transition to a social mode of play3, and later reduce their volume of overall play. The large decrease in population can likely be attributed to players becoming bored with the game. That is, once the initial excitement and novelty of the game wears off, players spend less time playing the game. Following the population decrease in weeks 3-10, the number of vertices remains relatively constant until week 16, the week of January 1st, where a rapid, but temporary drop, in the total population occurs. One possible cause of this drop in population could be due to an Xbox Live service outage, although we find no record of such an event on the web. Over the course of the remaining weeks, the population slowly and mildly declines, reaching a minimum during the month of June, and then returning to the levels seen in week 10. This weak decline and growth pattern is likely due to players having to spend increasing amounts of time away from the game studying for end of semester/year exams, since the majority of players are between the ages of 16 and 24, as noted in [21]. This also explains the growth in popu- lation following the month of June, when nearly all schools have ended for the year. 6.2 Network Turnover Next, we study the rates at which players enter and exit the social network over time. Figure 3(left) plots the cumulative fraction of observed players as a function of week, w. Based on the dynamics observed in Fig. 2(right), it is not surprising to see that within the first 10 weeks of play, roughly 60% of the network’s population has appeared in the network at least once. One might expect the population to grow exponentially, as observed in weeks 0-10, and then become constant, indicating that a large and constant number of players enter the network early and then consistently re- sold 3Reach the sale. http://en.wikipedia.org/wiki/Halo:_Reach) nearly the million game first day of copies of (see on 4 appear week after week. However, the dynamics that play out following week 10 indicate that the remaining 40% of the population continues to enter the network at a nearly constant rate. This linear growth may indeed be due to new players entering the social network, however, it may also be due, in part, to existing players changing their gamer tags, a relatively simple and inexpensive transaction (a player may change their gamertag once for free). The relatively constant size of the network after week 10 and the constant inflow of new players suggests that an equally sized portion of the population also exits the net- work over time, producing a “dynamic equilibrium”. Indeed, Figure 3(left-center) plots the fraction of players that reap- pear at least once on or after week, w. While the dynamics in Figure 2(right) indicate players may enter the network and play a large quantity of games with friends and then exit, we find this not to be the case. The steady, nearly lin- ear decline in the number of players that re-appear in future network snap shots after week 10 indicates that players are not quick to leave the game permanently; a pattern that is likely the result of players establishing consistent schedules with their friends. 6.3 Network non-densification Next, we examine how the density of the network varies with its size. In many networks, including social networks, it has been shown that a network densifies with the number of vertices [20, 18]. That is, the number of edges in a network grows super linearly with the number of nodes. However, the friendship network studied here does not exhibit this pattern. As shown in Figure 3(right-center), the number of edges in the network grows linearly with the number of the vertices under both thresholds. A super linear relationship between vertices and edges would suggest that as the net- work grows in size, players would acquire increasing numbers of friends. The non-densification of the network is also expressed in Figure 3(right), which plots the network’s mean degree as a function of week, w. The mean degree of vertices remains relatively constant over time, with the exception of week 16, further demonstrating that the network does not densify over time. The linear relationship between vertices and edges in the e c n a t s i d c i s e d o e g n a e M 20 18 16 14 12 10 8 0 5.6 5.4 5.2 5.0 4.8 4.6 4.4 4.2 4.0 0 Tail oversampled Configuration model 5 10 15 20 25 30 35 40 45 Tail undersampled Configuration model 5 10 15 25 20 Week, w 30 35 40 45 ) s n o i l l i m ( e z i s t n e n o p m o c t n a G i 3.5 3.0 2.5 2.0 1.5 1.0 0.5 0.0 0 5 4 3 2 1 0 0 Tail oversampled Configuration model 5 10 15 20 25 30 35 40 45 Tail undersampled Configuration model 0.16 0.14 0.12 0.10 0.08 t n e i c i f f e o c g n i r e t s u l c n a e M Tail oversampled Tail undersampled 0.35 0.30 0.25 0.20 0.15 0.10 t n e i c i f f e o c g n i r e t s u l c n a e M 5 10 15 25 20 Week, w 30 35 40 45 0.06 0 5 10 15 25 20 Week, w 30 35 40 45 0.05 2 Tail oversampled Tail undersampled 6 8 14 4 Consecutive weeks played, c 10 12 16 Figure 4: (Left) Mean geodesic distance between 1000 randomly selected pairs of vertices in the network’s giant component (Left-Center) Giant component size as a function of week, w. (Right-Center) Mean clustering coefficient as a function of week, w. (Right) Mean clustering coefficient as a function of consecutive weeks played, c network should come as no surprise. Establishing a link in Reach comes at a high social cost. Players must spend considerable time coordinating when and how often to play. Additionally, players must invest significant portions of time interacting with one another over the course of many games. These conditions make it difficult and time prohibitive for players to establish increasing numbers of friendships as the network grows, even though many may be available. This pattern contrasts with other online social networks, where creating an edge is as simple and cheap as accepting a friend request [18]. This result indicates network densification is not a universal property of dynamic networks and that the cost of establish- ing links is likely an important underlying mechanism which controls the property. Thus, we should expect to find den- sification patterns in networks where linking is cheap and non-densification where establishing a link is expensive. 6.4 Giant component Like many other social networks, the Reach friendship net- work is composed of many disconnected components of vary- ing sizes (see Fig. 2, right). Here, we study the dynamics and connectedness of the network’s giant component, which contains between roughly 80-90% of the network’s vertices and compare it to random networks generated via the Con- figuration Model, using the degree sequences of each network snapshot [28]. The geodesic distance between vertices is defined as the shortest path connecting them [27]. We estimate the mean geodesic distance, also known as the average diameter, of the network at each week, w, by taking the mean value of the geodesic distances of 1,000 randomly selected pairs of vertices from the giant component. As shown in Figure 4(left), we find the distance between ver- tices in the giant component to be relatively constant, with the exception of week 16, and equal to roughly 10 or 4.5 for over and under sampled tail thresholds respectively. This constant, non-shrinking diameter pattern contrasts with ob- servations in citation [20] and other social networks [18]. The mean pair-wise distances of the friendship networks are also larger than that of the Configuration Model based ran- dom networks. This is not surprising since random graphs have no clustering. That is, in the Configuration Model net- works, edges are placed between nodes at random, thereby creating a giant component with a smaller diameter, whereas in the friendship networks, edges tend to be placed within groups rather than between them, inducing a giant compo- nent with a larger diameter. Additionally, and as expected, the friendship network’s clustering structure creates giant components of smaller size, when compared to the Config- uration Model graphs (see Fig. 4, left-center). That is, the clustering structure produces more disconnected groups of vertices in the friendship network than in the Configuration Model. 6.5 Group dynamics Recall, that a non-trivial fraction (between 16-20%) of the overall population in Reach is composed of tightly knit groups (see Fig. 2, left). Here we study how clustering amongst players evolves over time. Figure 4(right-center) plots the mean vertex level clustering coefficient over the course of the data’s 44 week time span. During the first week, the network is clustered nearly as much as during its peak. This indicates the first week’s small population of players are more social. That is, they play more in groups than the players in the immediately following weeks. After week 1, we observe a parabolic trajectory of the mean vertex level clustering coefficient. This pattern indicates that, through week 25, an increasing fraction of players tend to interact in increasingly connected groups. After this peak, the clustering within the network decreases, indicating these groups deteriorate and players choose to interact more in a pairwise fashion. We also study how clustering correlates with play habits. For each player in the network, we calculate the largest con- secutive number of weeks the player appears in the data. For each set of players playing c consecutive weeks, we compute the mean clustering coefficient. Figure 4(right) plots the mean clustering coefficient as a function of consecutive weeks played and indicates a positive correlation between the number of consecutive weeks played and clustering coefficient (oversampled tail r2 = 0.85, p ≪ 0.001, undersampled tail r2 = 0.81, p ≪ 0.001). This pat- tern indicates that socially engaged players, who are mem- bers of increasingly connected groups, are retained and en- gaged in the system for longer and more consistent periods of time. 7. CONCLUSIONS Here, we studied the evolution of a novel online social net- work within the popular online game Halo: Reach, which we inferred from billions of interactions between tens of mil- lions of individuals. We find an interesting two-phase pat- tern in the structural turnover of the graph, with a large “churn” in the beginning, as individuals try out the system briefly and then leave, followed by a more prolonged “dy- namic equilibrium” period, characterized by a stable-sized giant component with roughly equal rates of vertices join- ing and leaving. Furthermore, we find that the friendship network does not densify over time and its diameter does not shrink, in contrast to other online social networks. This particular pattern is likely attributable to the high-cost of friendship links in this network, which require genuine and prolonged investment of time in order to maintain. This “high cost” requirement contrasts with the low- or zero-cost of maintaining links in most other online social networks. As a result, it seems likely that other online social networks with high costs for link formation and maintenance would also exhibit non-densifying patterns. One relatively understudied aspect of online social network structure is the behavior of small groups of friends. In Halo, these groups have a functional purpose, as they constitute a coherent “team” of players that engage the system together. We find that the local network density (cluster coefficient) amongst individuals tends to increase over the first 25 weeks of our study period and then declines. Additionally, we find that a player’s clustering coefficient is positively correlated with consecutive numbers of weeks played. This indicates players who are more socially engaged within the game are also more engaged in game play itself. The long term financial success of many online games, in- cluding Reach, rely not only on selling millions of copies of the game, but also on retaining players through the sale of subscription based online services. We observe that players who remain in the social network the longest are members of tighter knit groups than others. This suggests that the social aspect of Reach has a strong influence on the play patterns of its members. That is, the level of local social engagement with friends appears to correlate strongly with long-term engagement with the game itself. One interesting question for future work is whether the overall efficacy of the game’s matchmaking algorithm can be improved by explicitly ac- counting for the synergistic effect of playing with friends. That is, providing additional opportunities for friendship to engage socially with each other may facilitate the overall en- gagement of more weakly connected social groups, who may otherwise disengage the game earlier than desired. In short, the parabolic structure of the network’s cluster- ing suggests that groups may form and disband over time. Studying this pattern in more detail and understanding its effects on other play patterns, such as its influence on compe- tition outcomes and participation in different types of com- petitions, would shed light on how group dynamics applies to online social systems and how group skill and preferences evolve over time. Finally, the temporal patterns observed in the Halo friend- ship graph demonstrate the utility of online games for study- ing social networks, shed new light on empirical temporal graph patterns, and clarify the claims of universality of net- work densification. We look forward to future studies ex- ploring other dynamical aspects of the Halo data and the social networks embedded in other online games. 8. ACKNOWLEDGMENTS We thank Abigail Jacobs for helpful discussions, Chris Schenk for his help developing the data acquisition system and web survey, and Bungie Inc. for providing access to the data. This work was funded in part by the James S. McDonnell Foundation. 9. REFERENCES [1] M. Ahmad, B. Keegan, J. Srivastava, D. Williams, and N. Contractor. Mining for gold farmers: Automatic detection of deviant players in MMOGs. In Internat. Conf. on Comp. Science and Engineering, pages 340–345. IEEE, 2009. [2] Y.-Y. Ahn, S. Han, H. Kwak, S. Moon, and H. Jeong. Analysis of topological characteristics of huge online social networking services. In Proc. World Wide Web, pages 835–844. ACM, 2007. [3] E. Bakshy, M. Simmons, D. Huffaker, C. Teng, and L. Adamic. The social dynamics of economic activity in a virtual world. Proc. Fourth Internat. AAAI Conf. on Weblogs and Social Media, 1001:48103, 2010. [4] A.-L. Barab´asi and R. Albert. Emergence of scaling in random networks. Science, 286(5439):509–512, 1999. [5] J. Blackburn, R. Simha, N. Kourtellis, X. Zuo, M. Ripeanu, J. Skvoretz, and A. Iamnitchi. Branded with a scarlet C: cheaters in a gaming social network. In Proc. World Wide Web, pages 81–90. ACM, 2012. [6] E. Castronova, D. Williams, C. Shen, R. Ratan, L. Xiong, Y. Huang, and B. Keegan. As real as real? Macroeconomic behavior in a large-scale virtual world. New Media & Society, 11(5):685, 2009. [7] A. Clauset and N. Eagle. Persistence and periodicity in a dynamic proximity network. In DIMACS Workshop on Computational Methods for Dynamic Interaction Networks, pages 1–5, 2007. [8] A. Clauset, M. E. Newman, and C. Moore. Finding community structure in very large networks. Physical review E, 70(6):066111, 2004. [9] Entertainment Software Association. Essential Facts about the Compute and Video Game Industry, 2011. [10] P. Erdos and A. Renyi. On random graphs I. Publ. Math. Debrecen, 6:290–297, 1959. [11] D. Garcia, P. Mavrodiev, and F. Schweitzer. Social resilience in online communities: The autopsy of friendster. arXiv preprint arXiv:1302.6109, 2013. [12] M. Girvan and M. E. Newman. Community structure in social and biological networks. Proc. National Academy of Sciences, 99(12):7821–7826, 2002. [13] J. Huang, T. Zimmermann, N. Nagapan, C. Harrison, and B. C. Phillips. Mastering the art of war: how patterns of gameplay influence skill in halo. In Proc. Conf. on Human Factors in Computing Systems, pages 695–704. ACM, 2013. performance prediction in massively multiplayer online role-playing games (MMORPGs). Advances in Know. Discovery and Data Mining, pages 71–80, 2010. [31] K. Shim and J. Srivastava. Team performance prediction in massively multiplayer online role-playing games (MMORPGs). In Internat. Conf. on Social Computing, pages 128–136. IEEE, 2010. [32] K. J. Shim, S. Damania, C. DeLong, and J. Srivastava. Player and team performance in Everquest II and Halo 3. IEEE Potentials, 30(5), 2011. [33] M. Szell, R. Lambiotte, and S. Thurner. Multirelational organization of large-scale social networks in an online world. Proc. Natl. Acad. Sci. (USA), 107(31):13636–13641, 2010. [34] J. Ugander, B. Karrer, L. Backstrom, and C. Marlow. The anatomy of the facebook social graph. arXiv preprint arXiv:1111.4503, 2011. [35] D. J. Watts and S. H. Strogatz. Collective dynamics of small-world networks. Nature, 393(6684):440–442, 1998. [14] Y. Huang, C. Shen, D. Williams, and N. Contractor. Virtually there: Exploring proximity and homophily in a virtual world. In Internat. Conf. on Comp. Science and Engineering, volume 4, pages 354–359. IEEE, 2009. [15] Y. Huang, M. Zhu, J. Wang, N. Pathak, C. Shen, B. Keegan, D. Williams, and N. Contractor. The formation of task-oriented groups: Exploring combat activities in online games. In Internat. Conf. on Comp. Science and Engineering, pages 122–127. IEEE, 2009. [16] D. Huffaker, J. Wang, J. Treem, M. Ahmad, L. Fullerton, D. Williams, M. Poole, and N. Contractor. The social behaviors of experts in massive multiplayer online role-playing games. In Internat. Conf. on Comp. Science and Engineering, volume 4, pages 326–331. IEEE, 2009. [17] B. Keegan, M. Ahmed, D. Williams, J. Srivastava, and N. Contractor. Dark gold: Statistical properties of clandestine networks in massively multiplayer online games. In Internat. Conf. on Social Computing, pages 201–208. IEEE, 2010. [18] R. Kumar, J. Novak, and A. Tomkins. Structure and evolution of online social networks. In Proc. Knowledge discovery and data mining, pages 611–617, New York, NY, USA, 2006. ACM. [19] H. Kwak, C. Lee, H. Park, and S. Moon. What is twitter, a social network or a news media? In Proc. World Wide Web, pages 591–600. ACM, 2010. [20] J. Leskovec, J. Kleinberg, and C. Faloutsos. Graphs over time: densification laws, shrinking diameters and possible explanations. In Proc. Knowledge discovery in data mining, pages 177–187. ACM, 2005. [21] W. Mason and A. Clauset. Friends FTW! Friendship and competition in Halo: Reach. In Proc. Computer Supported Coop. Work and Social Comp., 2013. [22] S. Merritt and A. Clauset. Environmental structure and competitive scoring advantages in team competitions. arXiv preprint arXiv:1304.1039, 2013. [23] S. Merritt, A. Z. Jacobs, W. Mason, and A. Clauset. Detecting friendship within dynamic online interaction networks. arXiv preprint arXiv:1303.6372, 2013. [24] S. Milgram. The small world problem. Psychology today, 2(1):60–67, 1967. [25] A. Mislove, M. Marcon, K. P. Gummadi, P. Druschel, and B. Bhattacharjee. Measurement and analysis of online social networks. In Proc. Internet measurement, pages 29–42. ACM, 2007. [26] M. E. Newman. The structure and function of complex networks. SIAM review, 45(2):167–256, 2003. [27] M. E. Newman. Networks: an introduction. OUP Oxford, 2010. [28] M. E. Newman, S. H. Strogatz, and D. J. Watts. Random graphs with arbitrary degree distributions and their applications. Physical Review E, 64(2):026118, 2001. [29] K. Shim, K. Hsu, S. Damania, C. DeLong, and J. Srivastava. An exploratory study of player and team performance in multiplayer first-person-shooter games. In Internat. Conf. on Social Computing, pages 617–620. IEEE, 2011. [30] K. Shim, R. Sharan, and J. Srivastava. Player
1805.03285
1
1805
2018-05-08T21:02:07
Deep Neural Networks for Optimal Team Composition
[ "cs.SI", "physics.soc-ph" ]
Cooperation is a fundamental social mechanism, whose effects on human performance have been investigated in several environments. Online games are modern-days natural settings in which cooperation strongly affects human behavior. Every day, millions of players connect and play together in team-based games: the patterns of cooperation can either foster or hinder individual skill learning and performance. This work has three goals: (i) identifying teammates' influence on players' performance in the short and long term, (ii) designing a computational framework to recommend teammates to improve players' performance, and (iii) setting to demonstrate that such improvements can be predicted via deep learning. We leverage a large dataset from Dota 2, a popular Multiplayer Online Battle Arena game. We generate a directed co-play network, whose links' weights depict the effect of teammates on players' performance. Specifically, we propose a measure of network influence that captures skill transfer from player to player over time. We then use such framing to design a recommendation system to suggest new teammates based on a modified deep neural autoencoder and we demonstrate its state-of-the-art recommendation performance. We finally provide insights into skill transfer effects: our experimental results demonstrate that such dynamics can be predicted using deep neural networks.
cs.SI
cs
Deep Neural Networks for Optimal Team Composition Anna Sapienza∗ Palash Goyal∗ Emilio Ferrara USC Information Sciences Institute Marina del Rey, CA, USA USC Information Sciences Institute Marina del Rey, CA, USA USC Information Sciences Institute Marina del Rey, CA, USA [email protected] [email protected] [email protected] 8 1 0 2 y a M 8 ] I S . s c [ 1 v 5 8 2 3 0 . 5 0 8 1 : v i X r a ABSTRACT Cooperation is a fundamental social mechanism, whose effects on human performance have been investigated in several environ- ments. Online games are modern-days natural settings in which cooperation strongly affects human behavior. Every day, millions of players connect and play together in team-based games: the patterns of cooperation can either foster or hinder individual skill learning and performance. This work has three goals: (i) identify- ing teammates' influence on players' performance in the short and long term, (ii) designing a computational framework to recommend teammates to improve players' performance, and (iii) setting to demonstrate that such improvements can be predicted via deep learning. We leverage a large dataset from Dota 2, a popular Multi- player Online Battle Arena game. We generate a directed co-play network, whose links' weights depict the effect of teammates on players' performance. Specifically, we propose a measure of net- work influence that captures skill transfer from player to player over time. We then use such framing to design a recommendation system to suggest new teammates based on a modified deep neural autoencoder and we demonstrate its state-of-the-art recommen- dation performance. We finally provide insights into skill transfer effects: our experimental results demonstrate that such dynamics can be predicted using deep neural networks. CCS CONCEPTS • Information systems → Massively multiplayer online games; Data mining; • Computing methodologies → Neural networks; Factorization methods; KEYWORDS recommendation system, link prediction, deep neural network, graph factorization, multiplayer online games ACM Reference Format: Anna Sapienza∗, Palash Goyal∗, and Emilio Ferrara. 2018. Deep Neural Networks for Optimal Team Composition. In Proceedings of . ACM, New York, NY, USA, 10 pages. https://doi.org/10.1145/nnnnnnn.nnnnnnn *These authors contributed equally to this work. Permission to make digital or hard copies of part or all of this work for personal or classroom use is granted without fee provided that copies are not made or distributed for profit or commercial advantage and that copies bear this notice and the full citation on the first page. Copyrights for third-party components of this work must be honored. For all other uses, contact the owner/author(s). , , © 2018 Copyright held by the owner/author(s). ACM ISBN 978-x-xxxx-xxxx-x/YY/MM. https://doi.org/10.1145/nnnnnnn.nnnnnnn 1 INTRODUCTION Cooperation is a common mechanism present in real world systems at various scales and in different environments, from biological organization of organisms to human society. A great amount of research has been devoted to study the effects of cooperation on hu- man behavior and performance [6, 16, 27, 46]. These works include domains spanning from cognitive learning to psychology, and cover different experimental settings (e.g., classrooms, competitive sport environments, and games), in which people were encouraged to organize and fulfill certain tasks [5, 10, 12, 28]. These works provide numerous insights on the positive effect that cooperation has on individual and group performance. Many online games are examples of modern-day systems that revolve around cooperative behavior [24, 35]. Games allow players to connect from all over the world, establish social relationships with teammates [18], and coordinate together to reach a common goal, while trying at the same time to compete with the aim of improving their performance as individuals. Due to their recent growth in popularity, online games have become a great instru- ment for experimental research. Online games provide indeed rich environments yielding plenty of contextual and temporal features related to player's behaviors as well as social connection derived from the game organization in teams. In this work, we focus on the analysis of a particular type of online games, whose setting boosts players to collaborate to en- hance their performance both as individuals and teams: Multiplayer Online Battle Arena (MOBA) games. MOBA games, such as League of Legends (LoL), Defense of the Ancient 2 (Dota 2), Heroes of the Storm, and Paragon, are examples of match-based games in which two teams of players have to cooperate to defeat the opposing team by destroying its base/headquarter. MOBA players impersonate a specific character in the battle (a.k.a., hero), which has special abili- ties and powers based on its role, e.g., supporting roles, action roles, etc. The cooperation of teammates in MOBA games is essential to achieve the shared goal, as shown by prior studies [17, 51]. Thus, teammates might strongly influence individual players' behaviors over time. Previous research investigated factors influencing human perfor- mance in MOBA games. On the one hand, studies focus on identi- fying player's choices of role, strategies as well as spatio-temporal behaviors [17, 19, 41, 51] which drive players to success. On the other hand, performance may be affected by player's social inter- actions: the presence of friends [37, 39], the frequency of playing with or against certain players [35], etc. Despite the efforts of quantifying performance in presence of social connections, little attention has been devoted to connect the effect that teammates have in increasing or decreasing the actual player's skill level. Our study aims to fill this gap. We hypothesize that some teammates might indeed be beneficial to improve not , , Anna Sapienza∗, Palash Goyal∗, and Emilio Ferrara only the strategies and actions performed but also the overall skill of a player. On the contrary, some teammates might have a negative effect on a player's skill level, e.g., they might not be collaborative and tend to obstacle the overall group actions, eventually hindering player's skill acquisition and development. Our aim is to study the interplay between a player's performance improvement (resp., decline), throughout matches in the presence of beneficial (resp., disadvantageous) teammates. To this aim, we build a directed co-play network, whose links exist if two players played in the same team and are weighted on the basis of the player's skill level increase/decline. Thus, this type of network only take into account the short-term influence of teammates, i.e. the influence in the matches they play together. Moreover, we devise another formulation for this weighted network to take into account possible long-term effects on player's performance. This network incorporates the concept of "memory", i.e. the teammate's influence on a player persists over time, capturing temporal dynamics of skill transfer. We use these co-play networks in two ways. First, we set to quantify the structural properties of player's connections related to skill performance. Second, we build a teammate recommendation system, based on a modified deep neural network autoencoder, that is able to predict their most influential teammates. We show through our experiments that our teammate autoen- coder model is effective in capturing the structure of the co-play networks. Our evaluation demonstrates that the model significantly outperforms baselines on the tasks of (i) predicting the player's skill gain, and (ii) recommending teammates to players. Our predictions for the former result in a 9.00% and 9.15% improvement over re- porting the average skill increase/decline, for short and long-term teammate's influence respectively. For individual teammate recom- mendation, the model achieves an even more significant gain of 19.50% and 19.29%, for short and long-term teammate's influence respectively. Furthermore, we show that using a factorization based model only marginally improves over average baseline, showcasing the necessity of non-linear models for this task. 2 DATA COLLECTION AND PREPROCESSING Dota 2. Defense of the Ancient 2 (Dota 2) is a well-known MOBA game developed and published by Valve Corporation. First released in July 2013, Dota 2 rapidly became one of the most played games on the Steam platform, accounting for millions of active players. We have access to a dataset of one full year of Dota 2 matches played in 2015. The dataset, acquired via OpenDota [15], consists of 3,300,146 matches for a total of 1,805,225 players. For each match, we also have access to the match metadata, including winning status, start time, and duration, as well as to the players' performance, e.g., number of kills, number of assists, number of deaths, etc., of each player. As in most MOBA games, Dota 2 matches are divided into differ- ent categories (lobby types) depending on the game mode selected by players. As an example, players can train in the "Tutorial" lobby, or start a match with AI-controlled players in the "Co-op with AI" lobby. However, most players prefer to play with other human play- ers, rather than with AIs. Players can decide whether the teams they form and play against shall be balanced by the player's skill levels or not, respectively in the "Ranked matchmaking" lobby and Figure 1: Distribution of the number of matches per player in the Dota 2 dataset. the "Public matchmaking" lobby. For Ranked matches, Dota 2 imple- ments a matchmaking system to form balanced opposing teams. The matchmaking system tracks each player's performance throughout her/his entire career, attributing a skill level that increases after each victory and decreases after each defeat. For the purpose of our work, we take only into account the Ranked and Public lobby types, in order to consider exclusively matches in which 10 human players are involved. Preprocessing. We preprocess the dataset in two steps. First, we select matches whose information is complete. To this aim, we first filter out matches ended early due to connection errors or players that quit at the beginning. These matches can be easily identified through the winner status (equal to a null value if a connection error occurred) and the leaver status (players that quit the game before end have leaver status equal to 0). As we can observe in Fig. 1, the number of matches per player has a broad distribution, having minimum and maximum values of 1 and 1, 390 matches respectively. We note that many players are characterized by a low number of matches, either because they were new to the game at the time of data collection, or because they quit the game entirely after a limited number of matches. In this work we are interested in assessing a teammate's influence on the skill of a player. As described in the following section, we define the skill score of a player by computing his/her TrueSkill [23]. However, the average number of matches per player that are needed to identify the TrueSkill score in a game setting as the one of Dota 2 is 461. For the scope of this analysis, we then apply a second preprocessing step: we select all the players having at least 46 played matches. These two filtering steps yielded a final dataset including 87, 155 experienced players. 3 SKILL INFERENCE Dota 2 has an internal matchmaking ranking (MMR), which is used to track each player's level and, for those game modes requiring it, match together balanced teams. This is done with the main purpose of giving similar chance of winning to both teams. The MMR score depends both on the actual outcome of the matches (win/lose) and on the skill level of the players involved in the match (both teammates and opponents). Moreover, its standard deviation provides a level of uncertainty for each player's skill, with the 1https://www.microsoft.com/en-us/research/project/trueskill-ranking-system/ 0200400600800100012001400#ofmatches100101102103104105106#ofplayers Deep Neural Networks for Optimal Team Composition , , line shows the TrueSkill progress of the "average players". The con- fidence bands (standard deviations) shrinks with increasing number of matches, showing how the TrueSkill converges with increasing observations of players' performance.4 The variance is larger for high TrueSkill scores. Maintaining a high rank in Dota 2 becomes increasingly more difficult: the game is designed to constantly pair players with opponents at their same skill levels, thus competition in "Ranked matches" becomes increasingly harsher. The resulting score timelines will be used next to compute the link weights of the co-play network. Note that, although we selected only players with at least 46 matches, we observed timelines spanning terminal TrueSkill scores between 12 and 55. This suggests that experience alone (in terms of number of played matches) does not guarantee high TrueSkill scores, in line with prior literature [23]. 4 NETWORK GENERATION In the following, we explain the process to compute the co-play performance networks. In particular, we define a short-term perfor- mance network of teammates, whose links reflect TrueSkill score variations over time, and a long-term performance network, which allows to take memory mechanisms into account, based on the assumption that the influence of a teammate on a player can persist over time. 4.1 Short-term Performance Network Let us consider the set of 87, 155 players in our post-processed Dota 2 dataset, and the related matches they played. For each player p, we define the player history as the temporally ordered set Mp = [m0, m1, · · · , mN ] of matches played by p. Each mi ∈ Mp is further defined to be the 4-tuple (t1, t2, t3, t4) of player's teammates. Let us note that each match m in the dataset can be represented as a 4-tuple because we consider just Public and Ranked matches, whose opposing teams are composed by 5 human players each. We can now define for each teammate t of player p in match mi ∈ Mp the corresponding performance weight, as: = tsmi − tsmi−1 , wpt,mi (1) where, tsmi is the TrueSkill value of the player p after match mi ∈ Mp. Thus, weight wpt,mi captures the TrueSkill gain/loss of player p when playing with a given teammate t. This step generates as a result a time-varying directed network in which, at each time step (here the temporal dimension is defined by the sequence of matches), we have a set of directed links connecting together the players active at that time (i.e., match) to their teammates, and the relative weights based on the fluctuations of TrueSkill level of players. Next, we build the overall Short-term Performance Network (SPN), by aggregating the time-varying networks over the matches of each player. This network has a link between two nodes if the corresponding players were teammates at least once in the total temporal span of our dataset. Each link is then characterized by the sum of the previously computed weights. Thus, given player p and any possible teammate t in the network, their aggregated weight Figure 2: TrueSkill timelines of players in the top, bottom, and median decile. Lines show the mean of TrueSkill values at each match index, while shades indicate the related stan- dard deviations. uncertainty decreasing with the increasing number of player's matches. Player's skill is a fundamental feature that describes the over- all player's performance and can thus provide a way to evaluate how each player learns and evolves over time. Despite each player having access to his/her MMR, and rankings of master players be- ing available online, the official Dota 2 API does not disclose the MMR level of players at any time of any performed match. Provided that players' MMR levels are not available in any Dota 2 dataset (including ours), we need to reconstruct a proxy of MMR. We overcome this issue by computing a similar skill score over the available matches: the TrueSkill [23]. The TrueSkill ranking system has been designed by Microsoft Research for Xbox Live and it can be considered as a Bayesian extension of the well-known Elo rating system, used in chess [20]. The TrueSkill is indeed specifically developed to compute the level of players in online games that involve more than two players in a single match, such as MOBA games. Another advantage of using such ranking system is its similarity with the Dota 2 MMR. Likewise MMR, the TrueSkill of a player is represented by two main features: the average skill of a player µ and the level of uncertainty σ for the player's skill 2. Here, we keep track of the TrueSkill levels of players in our dataset after every match they play. To this aim, we compute the TrueSkill by using its open access implementation in Python 3. We first generate for each player a starting TrueSkill which is set to the default value in the Python library: µ = 25, and σ = 25 3 . Then, we update the TrueSkill of players on the basis of their matches' outcomes and teammates' levels. The resulting timelines of scores will be used in the following to compute the link weights of the co-play network. For illustrative purposes, Fig. 2 reports three aggregate TrueSkill timelines, for three groups of players: (i) the 10th percentile (bot- tom decile), (ii) the 90th percentile (top decile), and (iii) the median decile (45th-55th percentile). The red line shows the evolution of the average TrueSkill scores of the 10% top-ranked players in Dota 2 (at the time of our data collection); the blue line tracks the evolution of the 10% players reaching the lowest TrueSkill scores; and, the green 2https://www.microsoft.com/en-us/research/project/trueskill-ranking-system/ 3https://pypi.python.org/pypi/trueskill 4Note that the timelines have different length due to the varying number of matches played by players in each of the three deciles. In particular, in the bottom decile just one player has more than 600 matches. 020040060080010001200#matches20253035TrueSkillbottomdecilemediandeciletopdecile , , wpt is equal to N i =0 wpt = wpt,mi , (2) = tsmi − tsmi−1 if t ∈ mi, and 0 otherwise. The where wpt,mi resulting network has 87, 155 nodes and 4, 906, 131 directed links with weights wpt ∈ [−0.58, 1.06]. 4.2 Long-term Performance Network If skills transfer from player to player by means of co-play, the influence of a teammate on players should be accounted for in their future matches. We therefore would like to introduce a memory- like mechanism to model this form of influence persistence. Here we show how to generate a Long-term Performance Network (LPN) in which the persistence of influence of a certain teammate is taken into account. To this aim, we modify the weights by accumulating the discounted gain over the subsequent matches of a player as follows. Let us consider player p and his/her temporally ordered sequence of matches Mp = [m0, m1, · · · , mN ]. As previously intro- duced, mi ∈ Mp corresponds to the 4-tuple (t1, t2, t3, t4) of player's teammates in that match. For each teammate t of player p in match mi ∈ Mp the long-term performance weight is defined as = expi−ipt(cid:0)tsmi − tsmi−1 (cid:1) , wpt,mi (3) where ipt is the index of the last match in Mp in which player p played with teammate t. Note that, if the current match mi is a match in which p and t play together than ipt = i. Analogously to the SPN construction, we then aggregate the weights over the temporal sequence of matches. Thus, the links in the aggregated network will have final weights defined by Eq. (2). Conversely to the SPN, the only weights wpt,mi in the LPN being equal to zero are those corresponding to all matches previous to the first one in which p and t co-play. The final weights of the Long-term Performance Network are wpt ∈ [−0.54, 1.06]. As we can notice, the range of weights of SPN is close to the one found in LPN. However, these two weight formulations lead not only to different ranges of values but also to a different ranking of the links in the networks. When computing the Kendall's tau coefficient between the ranking of the links in the SPN and LPN, we find indeed that the two networks have a positive correlation (τ = 0.77 with p-value < 10−3) but the weights' ranking is changed. As our aim is to generate a recommending system for each player based on these weights, we further investigate the differences be- tween the performance networks, by computing the Kendall's tau coefficient over each player's ranking. Fig. 3 shows the distribu- tion of the Kendall's tau coefficient computed by comparing each player's ranking in the SPN and LPN. In particular, we have that just a small portion of players have the same teammate's ranking in both networks, and that the 87.8% of the remaining players have different rankings for their top-10 teammates. The recommending system that we are going to design will then provide a different recommendation based on the two performance networks. On the one hand, when using the SPN the system will recommend a team- mate that leads to an instant skill gain. As an example, this might be the case of a teammate that is good in coordinating the team but from which not necessarily the player learns how to improve his/her performance. On the other hand, when using the LPN the Anna Sapienza∗, Palash Goyal∗, and Emilio Ferrara Figure 3: Kendall's tau coefficient distribution computed by comparing each player's ranking in the short-term and long- term performance networks. Figure 4: Distribution of the number of occurrences per link, i.e. number of times a couple of teammates play together. system will recommend a teammate that leads to an increasing skill gain over the next matches. Thus, even if the instant skill gain with a teammate is not high, the player could learn some effective strategies and increase his/her skill gain in the successive matches. 4.3 LCC and network properties Given a co-play performance network (short-term or long-term), to carry out our performance prediction we have to take into ac- count only the links in the network having reliable weights. If two players play together just few times, the confidence we have on the corresponding weight is low. For example, if two players are teammates just one time their final weight only depends on that unique instance, and thus might lead to biased results. To face this issue, we computed the distribution of the number of occurrences a couple of teammates play together in our network (shown in Fig. 4) and set a threshold based on these values. In particular, we decided to retain only pairs that played more than 2 matches together. Finally, as many node embedding methods require a connected network as input [3], we extract the Largest Connected Compo- nent (LCC) of the performance network, which will be used for the performance prediction and evaluation. The LCC include the same number of nodes and links for both the SPN and the LPN. In partic- ular, it includes 38, 563 nodes and 1, 444, 290 links. We compare the characteristics of the initial network and its LCC in Tab. 1. −1.0−0.50.00.51.0#Kendall'staucoefficient010002000300040005000600070008000#ofplayers0100200300400500600700#ofoccurrences100101102103104105106#oflinks Deep Neural Networks for Optimal Team Composition , , Table 1: Comparison of the overall performance networks' characteristics and its LCC. Note that the number of nodes and links are the same for both the Short-term Performance Network (SPN) and the Long-term Performance Network (LPN), while the range of weights varies from one case to the other. LCC Network # nodes 87,155 38,563 # links 4,906,131 1,444,290 LPN weights [−0.54, 1.06] [−0.54, 1.06] SPN weights [−0.58, 1.06] [−0.58, 1.06] 5 PERFORMANCE PREDICTION In the following, we test whether the co-play performance networks have intrinsic structures allowing us to predict performance of players when matched with unknown teammates. Such a prediction, if possible, could help us in recommending teammates to a player in a way that would maximize his/her skill improvement. 5.1 Problem Formulation Consider the co-play performance network G = (V , E) with weighted adjacency matrix W . A weighted link (i, j, wij) denotes that player i gets a performance variation of wij after playing with player j. We can formulate the recommendation problem as follows. Given an observed instance of a co-play performance network G = (V , E) we want to predict the weight of each unobserved link (i, j) (cid:60) E and use this result to further predict the ranking of all other players j ∈ V ((cid:44) i) for each player i ∈ V . 5.2 Network Modeling Does the co-play performance network contain information or patterns which can be indicative of skill gain for unseen pairs of players? If that is the case, how do we model the network structure to find such patterns? Are such patterns linear or non-linear? To answer the above questions, we modify a deep neural net- work autoencoder and we test its predictive power against two classes of approaches widely applied in recommendation systems: (a) factorization based [2, 30, 45], and (b) deep neural network based [9, 29, 49]. 5.2.1 Factorization. In a factorization based model for directed networks, the goal is to obtain two low-dimensional matrices U ∈ Rn×d and V ∈ Rn×d with number of hidden dimensions d such that the following function is minimized (wij− < ui , vj >)2 + λ 2 (∥ui ∥2 + ∥vj∥2) f (U , V) =  (i, j)∈E The sum is computed over the observed links to avoid of penalizing the unobserved one as overfitting to 0s would deter predictions. Here, λ is chosen as a regularization parameter to give preference to simpler models for better generalization. 5.2.2 Traditional Autoencoder. Autoencoders are unsupervised neural networks that aim at minimizing the loss between recon- structed and input vectors. A traditional autoencoder is composed of two parts(cf., Figure 5): (a) an encoder, which maps the input vec- tor into low-dimensional latent variables; and, (b) a decoder, which maps the latent variables to an output vector. The reconstruction Figure 5: An example of deep autoencoder model. loss can be written as n ∥( xi − xi)∥2 2, i =1 L = (4) where xis are the inputs and xi = f (д(xi)). f (.) and д(.) are the decoder and encoder functions respectively. Deep autoencoders have recently been adapted to the network setting [9, 29, 49]. An algorithm proposed by Wang et al. [49] jointly optimizes the au- toencoder reconstruction error and Laplacian Eigenmaps [7] error to learn representation for undirected networks. However, this "Tra- ditional Autoencoder" equally penalizes observed and unobserved links in the network, while the model adapted to the network set- ting cannot be applied when the network is directed. Thus, we propose to modify the Traditional Autoencoder model as follows. 5.2.3 Teammate Autoencoder. To model directed networks, we propose a modification of the Traditional Autoencoder model, that takes into account the adjacency matrix representing the directed network. Moreover, in this formulation we only penalize the ob- served links in the network, as our aim is to predict the weight and the corresponding ranking of the unobserved links. We then write our "Teammate Autoencoder" reconstruction loss as: i =1 L = j=1∥2 2, ∥( xi − xi) ⊙ [ai, j]n (5) where aij = 1 if (i, j) ∈ E, and 0 otherwise. Here, xi represents ith row the adjacency matrix and n is the number of nodes in the network. Minimizing this loss functions yields the neural network weightsW and the learned representation of the network Y ∈ Rn×d. 5.3 Evaluation Framework 5.3.1 Experimental Setting. To evaluate the performance of the models on the task of teammates' recommendation, we use the cross-validation framework illustrated in Fig. 6. We randomly "hide" 20% of the weighted links and use the rest of the network to learn the embedding, i.e. representation, of each player in the network. We then use each player's embedding to predict the weights of the unobserved links. As the number of player pairs is too large, we evaluate the models on multiple samples of the co-player per- formance networks (similar to [22, 36]) and report the mean and standard deviation of the used metrics. Instead of uniformly sam- pling the players as performed in [22, 36], we use random walks [4] with random restarts to generate sampled networks with similar n 𝒚𝒊𝒙𝒊ෝ𝒙𝒊𝑫𝒆𝒄𝒐𝒅𝒆𝒓𝑬𝒏𝒄𝒐𝒅𝒆𝒓 , , Anna Sapienza∗, Palash Goyal∗, and Emilio Ferrara where index(i) is the index of the ith highest predicted link in the test network. Finally, to test the models' recommendations for each player, we define the Mean Absolute Normalized Error (MANE), which computes the normalized difference between predicted and actual ranking of the test links among the observed links and averages over the nodes. Formally, it can be written as (cid:12)(cid:12)(cid:12)rank i j=1 pr ed i Etr ain i i =1 MAN E(i) , Et est V V MAN E(i) = MAN E = (j)(cid:12)(cid:12)(cid:12) , (j) − ranktest Etest i i Figure 6: Evaluation Framework: The co-play network is divided into training and test networks. The parameters of the models are learned using the training network. We obtain multiple test subnetworks by using a random walk sampling with random restart and input the nodes of these subnetworks to the models for prediction. The predicted weights are then evaluated against the test link weights to obtain various metrics. Figure 7: Distribution of the weights of the network sampled by using random walk. degree and weight distributions as the original network. Fig. 7 illus- trates these distributions for the sampled network of 1,024 players (nodes). 5.3.2 Evaluation Metrics. We use Mean Squared Error (MSE), Mean Absolute Normalized Error (MANE), and AvgRec@k as evalu- ation metrics. MSE evaluates the accuracy of the predicted weights, whereas MANE and AvgRec@k evaluate the ranking obtained by the model. First, we compute MSE, typically used in recommendation sys- tems, to evaluate the error in the prediction of weights. We use the following formula for our problem: MSE = ∥wtest − wpr ed ∥2, where wtest is the list of weights of links in the test subnetwork, and wpr ed is the list of weights predicted by the model. Second, we use AvgRec@k to evaluate the ranking of the weights in the overall network. It is defined as: k AvдRec@k = i =1 wtest index(i) k , (j) represents the rank of the jth vertex in the list pr ed i where rank of weights predicted for the player i. 5.4 Results and Analysis Table 2: Average and standard deviation of player perfor- mance prediction (MSE) and teammate recommendation (MANE) for d = 1, 024 in both SPN and LPN. Baseline prediction Graph Factorization Traditional Autoencoder Teammate Autoencoder MSESP N 4.55/0.14 4.59/0.17 4.54/0.15 4.15/0.14 MANESP N 0.078/0.02 0.081/0.02 0.074/0.01 0.059/0.008 MSELP N 4.40/0.14 4.45/0.18 4.37/0.13 3.91/0.10 MANELP N 0.078/0.01 0.084/0.021 0.075/0.012 0.062/0.008 In the following, we evaluate the results provided by the Graph Factorization, the Traditional Autoencoder and our Teammate Au- toencoder. To this aim we first analyze the models' performance on both the SPN and the LPN with respect to the MSE measure, respectively in Fig. 8a and Fig. 9a. In this case, we compare the mod- els against an "average" baseline, where we compute the average performance of the players' couples observed in the training set and use it as a prediction for each hidden teammate link. Fig. 8a and Fig. 9a show the variation of the percentage of the MSE gain (average and standard deviation) while increasing the Model trainingNodelistEvaluationLinkweightsPredictionMSEMANEAvgRec@k−0.4−0.20.00.20.4weight0100200300400500600#oflinks Deep Neural Networks for Optimal Team Composition , , (a) (b) (c) Figure 8: Short-term Performance Network. (a) Mean Squared Error (MSE) gain of models over average prediction. (b) Mean Absolute Normalized Error (MAN E) gain of models over average prediction. (c) AvдRec@k of models. (a) (b) (c) Figure 9: Long-term Performance Network. (a) Mean Squared Error (MSE) gain of models over average prediction. (b) Mean Absolute Normalized Error (MAN E) gain of models over average prediction. (c) AvдRec@k of models. number of latent dimensions d for in each model. We can observe that the Graph Factorization model generally performs worse than the baseline, with values in [−1.64%,−0.56%] and average of -1.2% for the SPN and values in [−1.35%,−0.74%] and average of -1.05% for the LPN. This suggests that the performance networks of Dota 2 require non-linearity to capture their underlying structure. How- ever, a traditional non-linear model is not enough to outperform the baseline. The Traditional Autoencoder reaches indeed marginal improvements: values in [0.0%, 0.55%] and average gain of 0.18% for the SPN; values in [0.0%, 0.51%] and average gain of 0.20% for the LPN. On the contrast, our Teammate Autoencoder achieves substantial gain over the baseline across the whole spectrum and its performance in general increases for higher dimensions (they can retain more structural information). The average MSE gain for different dimensions over the baseline of the Teammate Autoen- coder spans between 6.34% and 11.06% in the SPN and from 6.68% to 11.34% for the LPN, with an average gain over all dimensions of 9.00% for the SPN and 9.15% for the LPN. We also computed the MSE average over 10 runs and d = 1, 024, shown in Tab. 2, which decreases from the baseline prediction of 4.55 to our Teammate Autoencoder prediction of 4.15 for for the SPN, and from 4.40 to 3.91 for the LPN. SPN and the LPN. Analogously to the MSE case, the Graph Factoriza- tion performs worse than the baseline (values in [−3.34%,−1.48%] with average gain of -2.37% for SPN and values in [−3.78%,−0.78%] -2.79% for LPN) despite the increment in the number of dimen- sions. The Traditional Autoencoder achieves marginal gain over the baseline for dimensions higher than 128 ([0.0%, 0.37%] for SPN and [0.0%, 0.5%] for LPN), with an average gain over all dimensions of 0.16% for SPN and 0.19% for LPN. Our model attains instead sig- nificant percentage gain in individual recommendations over the baseline. For the SPN, it achieves an average percentage of MANE gain spanning from 14.81% to 22.78%, with an overall average of 19.50%. For the LPN, the average percentage of MANE gain spans from 16.81% to 22.32%, with an overall average of 19.29%. It is worth noting that the performance in this case does not monotonically increase with dimensions. This might imply that for individual rec- ommendations the model overfits at higher dimensions. We report the average value of MANE in Tab. 2 for d = 1, 024. Our model obtains average values of 0.059 and 0.062, for the SPN and LPN respectively, compared to 0.078 of the average baseline for both cases. We then compare the models' performance in providing individ- ual recommendations by analyzing the MANE metric. Fig. 8b and Fig. 9b show the percentage of the MANE gain for different dimen- sions computed against the average baseline respectively for the Finally, we compare our models against the ideal recommen- dation in the test subnetwork to understand how close our top recommendations are to the ground truth. To this aim, we report the AvgRec@k metric, which computes the average weight of the top k links recommended by the models. In Fig. 8c and Fig. 9c, we 32641282565121024d−5.0−2.50.02.55.07.510.012.515.017.5%MSEgainGraphFactorizationTraditionalAutoencoderTeammateAutoencoder32641282565121024d−10010203040%MANEgainGraphFactorizationTraditionalAutoencoderTeammateAutoencoder0255075100125150175200k0.00.10.20.30.40.50.60.7AvgRec@kTeammateAutoencoderTraditionalAutoencoderGraphFactorizationMaximum(Theoretical)32641282565121024d−5.0−2.50.02.55.07.510.012.515.017.5%MSEgainGraphFactorizationTraditionalAutoencoderTeammateAutoencoder32641282565121024d−10010203040%MANEgainGraphFactorizationTraditionalAutoencoderTeammateAutoencoder0255075100125150175200k0.00.10.20.30.40.50.60.7AvgRec@kTeammateAutoencoderTraditionalAutoencoderGraphFactorizationMaximum(Theoretical) , , can observe that the Teammate Autoencoder significantly outper- forms the other models, both for the SPN and LPN respectively. For the SPN, the link with the highest predicted weight by our model achieves a performance gain of 0.38 as opposed to 0.1 for Graph Factorization. This gain is close to the ideal prediction which achieves 0.52. For the LPN, instead, our model achieves a perfor- mance gain of 0.3 as opposed to 0.1 for Graph Factorization. The performance of our model remains higher for all values of k. This shows that the ranking of the links achieved by our model is close to the ideal ranking. Note that the Traditional Autoencoder yields poor performance on this task which signifies the importance of relative weighting of observed and unobserved links. 6 RELATED WORK There is a broad body of research focusing on online games to identify which characteristics influence different facets of human behaviors. On the one hand, this research is focused on the cognitive aspects that are triggered and affected when playing online games, including but not limited to gamer motivations to play [11, 25, 52], learning mechanisms [43, 44], and player performance and acquisition of expertise [42]. On the other hand, players and their performance are classified in terms of in-game specifics, such as combat patterns [17, 51], roles [19, 33], and actions [26, 41, 50]. Aside from these different gaming features, multiplayer online games especially distinguish from other games because of their inherent cooperative design. In such games, players have not only to learn individual strategies, but also to organize and coordinate to reach better results. This intrinsic social aspect has been a fo- cal research topic [18, 24, 35]. In [13], authors show that multi- player online games provide an environment in which social inter- actions among players can evolve into strong friendship relation- ships. Moreover, the study shows how the social aspect of online gaming is a strong component for players to enjoy the game. An- other study [39, 40] ranked different factors that influence player performance in MOBA games. Among these factors, the number of friends resulted to have a key role in a successful team formation. In the present work, we focused on social contacts at a higher level: co-play relations. Teammates, either friends or strangers, can affect other players' styles through communication, by trying to exert influence over others, etc. [31]. Moreover, we leveraged these teammate-related effects on player performance to build a teammate recommendation system for players in Dota 2. Recommendation systems have been widely studied in the litera- ture on applications such as movies, music, restaurants and grocery products [21, 32, 34, 48]. The current work on such systems can be broadly categorized into: (i) collaborative filtering [45], (ii) con- tent based filtering [38], and (iii) hybrid models [8]. Collaborative filtering is based on the premise that users with similar interests in the past will tend to agree in the future as well. Content based models learn the similarity between users and content descriptions. Hybrid models combine the strength of both of these systems with varying hybridization strategy. In the specific case of MOBA games, recommendation systems are mainly designed to advise players on the type of character (hero) they impersonate5 [1, 14]. Few works addressed the problem 5Dota Picker. http://dotapicker.com/ Anna Sapienza∗, Palash Goyal∗, and Emilio Ferrara of recommending teammates in MOBA games. In [47], authors discuss how to improve matchmaking for players based on the teammates they had in their past history. They focus on the creation and analysis of the properties of different networks in which the links are formed based on different rules, e.g., players that played together in the same match, in the same team, in adversarial teams, etc. These networks are then finally used to design a matchmaking algorithm to improve social cohesion between players. However, the author focus on different relationships to build their networks and on the strength of network links to design their algorithm, while no information about the actual player performance is taken into account. Here, we aim at combining both the presence of players in the same team (and the number of times they play together) and the effect that these combinations have on player performance, by looking at skill gain/loss after the game. 7 CONCLUSIONS In this paper, we set to study the complex interplay between co- operation, teams and teammates' recommendation, and players' performance in online games. Our study tackled three specific prob- lems: (i) understanding short and long-term teammates' influence on players' performance; (ii) recommending teammates with the aim of improving players skills and performance; and (iii) demon- strating a deep neural network that can predict such performance improvements. We used Dota 2, a popular Multiplayer Online Battle Arena game hosting millions of players and matches every day, as a virtual lab- oratory to understand performance and influence of teammates. We used our dataset to build a co-play network of players, with weights representing a teammate's short-term influence on a player performance. We also developed a variant of this weighting al- gorithm that incorporates a memory mechanism, implementing the assumption that player's performance and skill improvements carry over in future games (i.e. long-term influence): influence can be intended as a longitudinal process that can improve or hinder player's performance improvement over time. With this framework in place, we demonstrated the feasibility of a recommendation system that suggests new teammates, which can be beneficial to a player to play with to improve their individ- ual performance. This system, based on a modified autoencoder model, yields state-of-the-art recommendation accuracy, outper- forming graph factorization techniques considered among the best in recommendation systems literature, closing the existing gap with the maximum improvement that is theoretically achievable. Our experimental results suggest that skill transfer and performance im- provement can be accurately predicted with deep neural networks. We plan to extend this work in multiple future directions: from a theoretical standpoint, we intend to determine whether our frame- work can be generalized to generate recommendations and predict team and individual performance in a broader range of scenarios, beyond online games. We also plan to demonstrate, from an empir- ical standpoint, that the recommendations produced by our system can be implemented in real settings. We will carry out randomized- control trials in lab settings to test whether individual performance in teamwork-based tasks can be improved. One additional direction Deep Neural Networks for Optimal Team Composition , , will be to extend our framework to recommend incentives along- side teammates: this to establish whether we can computationally suggest incentive-based strategies to further motivate individuals and improve their performance within teams. ACKNOWLEDGMENTS The authors are grateful to DARPA for support (grant #D16AP00115). This project does not necessarily reflect the position/policy of the Government; no official endorsement should be inferred. Approved for public release; unlimited distribution. REFERENCES [1] Atish Agarwala and Michael Pearce. 2014. Learning Dota 2 team compositions. Technical Report. Technical report, Stanford University. [2] Amr Ahmed, Nino Shervashidze, Shravan Narayanamurthy, Vanja Josifovski, and Alexander J Smola. 2013. Distributed large-scale natural graph factorization. In Proceedings of the 22nd international conference on World Wide Web. ACM, 37–48. [3] Nesreen K Ahmed, Ryan A Rossi, Rong Zhou, John Boaz Lee, Xiangnan Kong, Theodore L Willke, and Hoda Eldardiry. 2017. A Framework for Generalizing Graph-based Representation Learning Methods. arXiv preprint arXiv:1709.04596 (2017). [4] Lars Backstrom and Jure Leskovec. 2011. Supervised random walks: predicting and recommending links in social networks. In Proceedings of the fourth ACM international conference on Web search and data mining. ACM, 635–644. [5] Victor Battistich, Daniel Solomon, and Kevin Delucchi. 1993. Interaction processes and student outcomes in cooperative learning groups. The Elementary School Journal 94, 1 (1993), 19–32. [6] Bianca Beersma, John R Hollenbeck, Stephen E Humphrey, Henry Moon, Don- ald E Conlon, and Daniel R Ilgen. 2003. Cooperation, competition, and team performance: Toward a contingency approach. Academy of Management Journal 46, 5 (2003), 572–590. [7] Mikhail Belkin and Partha Niyogi. 2001. Laplacian eigenmaps and spectral techniques for embedding and clustering. In NIPS, Vol. 14. 585–591. [8] Robin Burke. 2002. Hybrid recommender systems: Survey and experiments. User modeling and user-adapted interaction 12, 4 (2002), 331–370. [9] Shaosheng Cao, Wei Lu, and Qiongkai Xu. 2016. Deep neural networks for learning graph representations. In Proceedings of the Thirtieth AAAI Conference on Artificial Intelligence. AAAI Press, 1145–1152. [10] Marcus D Childress and Ray Braswell. 2006. Using massively multiplayer online role-playing games for online learning. Distance Education 27, 2 (2006), 187–196. [11] Dongseong Choi and Jinwoo Kim. 2004. Why people continue to play online games: In search of critical design factors to increase customer loyalty to online contents. CyberPsychology & behavior 7, 1 (2004), 11–24. [12] Elizabeth G Cohen. 1994. Restructuring the classroom: Conditions for productive small groups. Review of educational research 64, 1 (1994), 1–35. [13] Helena Cole and Mark D Griffiths. 2007. Social interactions in massively mul- tiplayer online role-playing gamers. CyberPsychology & Behavior 10, 4 (2007), 575–583. [14] Kevin Conley and Daniel Perry. 2013. How does he saw me? A recommendation engine for picking heroes in Dota 2. Np, nd Web 7 (2013). [15] Albert Cui, Howard Chung, and Nicholas Hanson-Holtry. [n. d.]. YASP 3.5 Million Data Dump. ([n. d.]). [16] Morton Deutsch. 1960. The effects of cooperation and competition upon group process. Group dynamics (1960), 552–576. [17] Anders Drachen, Matthew Yancey, John Maguire, Derrek Chu, Iris Yuhui Wang, Tobias Mahlmann, Matthias Schubert, and Diego Klabajan. 2014. Skill-based differences in spatio-temporal team behaviour in defence of the ancients 2 (dota 2). In Games media entertainment (GEM), 2014 IEEE. IEEE, 1–8. [18] Nicolas Ducheneaut, Nicholas Yee, Eric Nickell, and Robert J Moore. 2006. Alone together?: exploring the social dynamics of massively multiplayer online games. In Proceedings of the SIGCHI conference on Human Factors in computing systems. ACM, 407–416. [19] Christoph Eggert, Marc Herrlich, Jan Smeddinck, and Rainer Malaka. 2015. Clas- sification of player roles in the team-based multi-player game dota 2. In Interna- tional Conference on Entertainment Computing. Springer, 112–125. [20] Arpad E Elo. 1978. The rating of chessplayers, past and present. Arco Pub. [21] Yanjie Fu, Bin Liu, Yong Ge, Zijun Yao, and Hui Xiong. 2014. User preference learning with multiple information fusion for restaurant recommendation. In Proceedings of the 2014 SIAM International Conference on Data Mining. SIAM, 470–478. [22] Palash Goyal and Emilio Ferrara. 2017. Graph Embedding Techniques, Applica- tions, and Performance: A Survey. arXiv preprint arXiv:1705.02801 (2017). [23] Ralf Herbrich, Tom Minka, and Thore Graepel. 2007. TrueSkill: a Bayesian skill rating system. In Advances in neural information processing systems. 569–576. [24] Matthew Hudson and Paul Cairns. 2014. Measuring social presence in team- based digital games. Interacting with Presence: HCI and the Sense of Presence in Computer-mediated Environments (2014), 83. [25] Jeroen Jansz and Martin Tanis. 2007. Appeal of playing online first person shooter games. CyberPsychology & Behavior 10, 1 (2007), 133–136. [26] Daniel Johnson, Lennart E Nacke, and Peta Wyeth. 2015. All about that base: differing player experiences in video game genres and the unique case of moba games. In Proceedings of the 33rd Annual ACM Conference on Human Factors in Computing Systems. ACM, 2265–2274. [27] David W Johnson and Roger T Johnson. 1989. Cooperation and competition: Theory and research. Interaction Book Company. [28] David W Johnson, Geoffrey Maruyama, Roger Johnson, Deborah Nelson, and Linda Skon. 1981. Effects of cooperative, competitive, and individualistic goal structures on achievement: A meta-analysis. Psychological bulletin 89, 1 (1981), 47. [29] Thomas N Kipf and Max Welling. 2016. Variational Graph Auto-Encoders. arXiv preprint arXiv:1611.07308 (2016). [30] Yehuda Koren, Robert Bell, and Chris Volinsky. 2009. Matrix factorization tech- niques for recommender systems. Computer 42, 8 (2009). [31] Yubo Kou and Xinning Gui. 2014. Playing with strangers: Understanding tempo- rary teams in League of Legends. In Proceedings of the first ACM SIGCHI annual symposium on Computer-human interaction in play. ACM, 161–169. [32] Richard D Lawrence, George S Almasi, Vladimir Kotlyar, Marisa Viveros, and Sastry S Duri. 2001. Personalization of supermarket product recommendations. In Applications of Data Mining to Electronic Commerce. Springer, 11–32. [33] Choong-Soo Lee and Ivan Ramler. 2015. Investigating the impact of game features and content on champion usage in league of legends. Proceedings of the Foundation of Digital Games (2015). [34] George Lekakos and Petros Caravelas. 2008. A hybrid approach for movie recommendation. Multimedia tools and applications 36, 1 (2008), 55–70. [35] Alexandru Losup, Ruud Van De Bovenkamp, Siqi Shen, Adele Lu Jia, and Fernando Kuipers. 2014. Analyzing implicit social networks in multiplayer online games. IEEE Internet Computing 18, 3 (2014), 36–44. [36] Mingdong Ou, Peng Cui, Jian Pei, Ziwei Zhang, and Wenwu Zhu. 2016. Asymmet- ric transitivity preserving graph embedding. In Proc. of ACM SIGKDD. 1105–1114. [37] Hyunsoo Park and Kyung-Joong Kim. 2014. Social network analysis of high-level players in multiplayer online battle arena game. In International Conference on Social Informatics. Springer, 223–226. [38] Michael J Pazzani and Daniel Billsus. 2007. Content-based recommendation systems. In The adaptive web. Springer, 325–341. [39] Nataliia Pobiedina, Julia Neidhardt, Maria del Carmen Calatrava Moreno, and Hannes Werthner. 2013. Ranking factors of team success. In Proceedings of the 22nd International Conference on World Wide Web. ACM, 1185–1194. [40] Nataliia Pobiedina, Julia Neidhardt, MC Calatrava Moreno, L Grad-Gyenge, and H Werthner. 2013. On successful team formation. Technical Report. Technical report, Vienna University of Technology, 2013. Available at http://www. ec. tuwien. ac. at/files/OnSuccessfulTeamFormation. pdf. [41] Anna Sapienza, Alessandro Bessi, and Emilio Ferrara. 2017. Non-negative Tensor Factorization for Human Behavioral Pattern Mining in Online Games. arXiv preprint arXiv:1702.05695 (2017). [42] PG Schrader and Michael McCreery. 2008. The acquisition of skill and expertise in massively multiplayer online games. Educational Technology Research and Development 56, 5-6 (2008), 557–574. [43] Constance A Steinkuehler. 2004. Learning in massively multiplayer online games. In Proceedings of the 6th international conference on Learning sciences. International Society of the Learning Sciences, 521–528. [44] Constance A Steinkuehler. 2005. Cognition and learning in massively multiplayer online games: A critical approach. The University of Wisconsin-Madison. [45] Xiaoyuan Su and Taghi M Khoshgoftaar. 2009. A survey of collaborative filtering techniques. Advances in artificial intelligence 2009 (2009), 4. [46] John M Tauer and Judith M Harackiewicz. 2004. The effects of cooperation and competition on intrinsic motivation and performance. Journal of personality and social psychology 86, 6 (2004), 849. [47] Ruud Van De Bovenkamp, Siqi Shen, Alexandru Iosup, and Fernando Kuipers. 2013. Understanding and recommending play relationships in online social gaming. In Communication Systems and Networks (COMSNETS), 2013 Fifth Inter- national Conference on. IEEE, 1–10. [48] Aaron Van den Oord, Sander Dieleman, and Benjamin Schrauwen. 2013. Deep content-based music recommendation. In Advances in neural information process- ing systems. 2643–2651. [49] Daixin Wang, Peng Cui, and Wenwu Zhu. 2016. Structural deep network embed- ding. In Proceedings of the 22nd International Conference on Knowledge Discovery and Data Mining. ACM, 1225–1234. [50] Bang Xia, Huiwen Wang, and Ronggang Zhou. 2017. What Contributes to Success in MOBA Games? An Empirical Study of Defense of the Ancients 2. Games and Culture (2017), 1555412017710599. , , Anna Sapienza∗, Palash Goyal∗, and Emilio Ferrara [51] Pu Yang, Brent E Harrison, and David L Roberts. 2014. Identifying patterns in combat that are predictive of success in MOBA games.. In FDG. [52] Nick Yee. 2006. Motivations for play in online games. CyberPsychology & behavior 9, 6 (2006), 772–775.
1909.04252
1
1909
2019-09-10T03:05:56
Lifelog Patterns Analyzation using Graph Embedding based on Deep Neural Network
[ "cs.SI", "cs.LG" ]
Recently, as the spread of smart devices increases, the amount of data collected through sensors is increasing. A lifelog is a kind of big data to analyze behavior patterns in the daily life of individuals collected from various smart de-vices. However, sensor data is a low-level signal that makes it difficult for hu-mans to recognize the situation directly and cannot express relations clearly. It is also difficult to identify the daily behavior pattern because it records heterogene-ous data by various sensors. In this paper, we propose a method to define a graph structure with node and edge and to extract the daily behavior pattern from the generated lifelog graph. We use the graph convolution method to embeds the lifelog graph and maps it to low dimension. The graph convolution layer im-proves the expressive power of the daily behavior pattern by implanting the life-log graph in the non-Euclidean space and learns the patterns of graphs. Experi-mental results show that the proposed method automatically extracts meaningful user patterns from UbiqLog dataset. In addition, we confirm the usefulness by comparing our method with existing methods to evaluate performance.
cs.SI
cs
Lifelog Patterns Analyzation using Graph Embedding based on Deep Neural Network Wonsup Shin, Tae-Young Kim, and Sung-Bae Cho Department of Computer Science, Yonsei University, Seoul, Republic of Korea {wsshin2013, taeyoungkim, sbcho}@yonsei.ac.kr Abstract. Recently, as the spread of smart devices increases, the amount of data collected through sensors is increasing. A lifelog is a kind of big data to analyze behavior patterns in the daily life of individuals collected from various smart de- vices. However, sensor data is a low-level signal that makes it difficult for hu- mans to recognize the situation directly and cannot express relations clearly. It is also difficult to identify the daily behavior pattern because it records heterogene- ous data by various sensors. In this paper, we propose a method to define a graph structure with node and edge and to extract the daily behavior pattern from the generated lifelog graph. We use the graph convolution method to embeds the lifelog graph and maps it to low dimension. The graph convolution layer im- proves the expressive power of the daily behavior pattern by implanting the life- log graph in the non-Euclidean space and learns the patterns of graphs. Experi- mental results show that the proposed method automatically extracts meaningful user patterns from UbiqLog dataset. In addition, we confirm the usefulness by comparing our method with existing methods to evaluate performance. Keywords: Life log, multivariate temporal data, Graph pattern mining, Graph convolution, deep learning 1 Introduction Recently, as the use of smart devices has expanded, information technology for re- cording the daily life of individuals in the ubiquitous environment has been rapidly developing [1]. Using various sensors built in smart devices, various kinds of signals can be collected to recognize various situations of users [2]. In addition, data collected from smart devices can be automatically stored to retrieve and utilize past information [3]. However, as the amount of data becomes wider, it is difficult to establish an effi- cient storage structure considering scalability [4]. Also, it is difficult to extract daily behavior patterns as the data becomes complicated [5]. In this paper, we propose a graph pattern analyzation framework. It constructs graph from lifelogs and pattern extraction method for analyzation. We define the nodes of the graph structure using the context awareness extracted from the input signal of the smart device and connect the edges to express the semantic relation between the nodes clearly. We also propose a graph convolution method that extracts the daily behavior pattern from the generated lifelog graph. The graph convolution method embeds the lifelog graph and maps it to a lower dimension. The embedded lifelog graph is useful for find- ing frequent user patterns. We also use a novel adversarial auto-encoder model to gen- erate the non-Euclidean feature space. To verify the usefulness of the proposed method, we use UbiqLog (smartphone lifelogging) dataset provided by UCI machine learning repository. The UbiqLog dataset was collected by 35 smartphone users for two months and used the smartphone lifelogging tool. Figure 1 shows the life log data collected over time. Figure 1. UbiqLog data over time The rest of this paper is organized as follows. We discuss the related work on life log pattern extraction in Section 2. The proposed model is introduced in Section 3. We present the experiments and performance comparison with other methods in Section 4. We conclude this paper with remarks on future work in Section 5. 2 Related Work 2.1 Previous works to extract patterns from the lifelog As shown in Table 1, many researchers have studied various storage structures to extract patterns in the lifelog. The lifelog storage structure is typically divided into a linear structure that is stored over time and a graph structure that includes the relation- ship between data. This section outlines a variety of previous studies to compare with the proposed method. To illustrate the motivation of the proposed method, we introduce previous research that uses lifelog data. A. Shimojo et al. used a MySQL database to store food photographs and user weight data collected on Flickr [6]. They proposed a platform that can visualize the eating habit pattern using the SQL query in the constructed database. J. Gemmell et al. used a rela- tional database to record the user's position, calorie, and heart rate [8]. They proposed a platform that can efficiently retrieve information from a built-in lifelog database. These methods can manage the collected life logs by dividing them into tabular form, so that the redundancy can be minimized while maintaining the consistency of the data. However, when stored in table form, semantic reasoning between data is impossible and only formal queries are possible. H. Kim et al. Constructed an ontology graph to analyze the data collected through the health tracking system [9]. They classify the data using an ontology-based network and infer the meaning. H. Xu built a semantic network using data collected from smartphones [10]. They use the semantic relationship of the network to shorten the search time and increase the memory usage efficiency. This method can combine and structure lifelogs of various formats and can easily express the relationship and depend- ency between data. However, the larger the size of the data, the more complex the rea- soning becomes. It is also difficult to find patterns in higher dimensional structures. Category Lifelog linear structure Lifelog graph structure Table 1. Related works to extract patterns from the lifelog Author A. Shimojo [6] Year 2011 Description User eating and visualization platform using MySQL W. V. Sujansky [7] 2010 Check patient's health information through SQL query J. Gemmell [8] 2006 SQL-based personal everyday H. H. Kim [9] 2015 Ontology graph representing recording platform biometric data H. Xu [10] 2013 Graph search system utilizing semantic relations S. Lee [11] 2010 Ontology-based life log storage system 3 The Proposed Method 3.1 Overview of the Proposed Framework This paper proposes a framework for analyzing patterns of lifelog data such as cell phone logs. The overall structure of the proposed framework is shown in Fig 2. First, the proposed method expresses log data as a semantic network. This process makes it possible to efficiently express the semantic information of the log data. Second, we embed each network into latent space by using a graph convolution-based deep model. Through this, users' patterns can be expressed on latent space. Finally, we analyze the patterns of each users or groups by using learned encoders. 3.2 Graph Generation Process We set the semantics by applying the theory of General Social Survey, ConceptNet5, and Speech act theory to create a semantic network structure. Table 2 shows the seman- tics of connections for each node type. Our network consists of three types of nodes through four semantics. The source type nodes reflect actual log data. These store Figure 2. Proposed framework structure Table 2. Semantics of network From To sensor time source time Semantic contain start end will be source source time time Figure 3. An example of network information when the event occurs. The sensor type node reflects the event type. For example, if a user calls two people, there are source nodes for each phone number, which are connected to the 'call' sensor node. The time node reflects the time at which the event occurs. Also, these exist equally for each graph, regardless of the data. Through this, it is possible to represent events occurring in different graphs at the same time flow, and to reduce variation between graphs. Figure 3 shows an example of a network that can be created. 3.3 Graph Embedding Process We designed a graph embedding model inspired by [12]. [12] proposed the Adver- sarial Auto Encoder (AAE) model mapping latent space to Constant Curvature Mani- fold (CCM) M to improve the ability to express graph features in latent space. The CCM is defined as Eq. 1. ℳ = {𝑥 ∈ ℝ𝑑+1 < 𝑥, 𝑥 > = 𝜅−1} < 𝑥, 𝑦 > = 𝑥𝑇 ( 𝐼𝑑×𝑑 0 0 −1 ) 𝑦 (1) (2) The encoder of the proposed model uses the graph convolution layer [13]. Therefore, the input graph G is transformed according to the requirement of the layer. That is, the graph is represented by a node feature matrix 𝑋 , which represents the characteristics of the node, and an adjacent matrix 𝐴, which represents the connection relationship between the nodes. 𝐺 = {𝑋, 𝐴}. Where 𝑘 means the size of the feature vector of the node and n is the number of nodes. 𝑋 ∈ ℝ𝑛×𝑘 𝐴 ∈ ℝ𝑛×𝑛 = { 𝑚 0 𝑖𝑓 𝑖 𝑎𝑛𝑑 𝑗 𝑖𝑠 𝑚 𝑡𝑖𝑚𝑒𝑠 𝑗𝑜𝑖𝑛𝑒𝑑 𝑒𝑙𝑠𝑒 (3) (4) The proposed model has the same learning mechanism as the general AAE [14]. Among them, the auto-encoder part receives 𝑋 and 𝐴 as inputs and outputs 𝑋′ and 𝐴′. In this way, the encoder learns the feature extraction ability for the graph. The discrim- inator induces the result of the encoder to exist in the CCM. Also, to improve the graph imbedding efficiency, the membership function 𝜇(𝑧) is added to the learning process of the discriminator. 𝜇(𝑧) has a value of 1 at the point of perfect existence in the CCM, but, converges to 0 at the opposite case. Therefore, it helps the discriminator to learn steadily. Finally, the encoder model maps the characteristics of the graph to latent space composed of CCM. Equations 5, 6, 7 and 8 show the object function of the auto-en- coder, the object function of the discriminator, the encoder loss from discriminator, and the membership function, respectively. Where 𝜙, 𝜃 and 𝜆 are weights of each models. And 𝜁 is a hyperparameter that controls the width of the curve. 𝐿𝐴𝐸(𝜙, 𝜃, 𝑋, 𝐴) = 𝔼𝐸𝜙(𝑧𝑋,𝐴)[log(𝐷𝜃(𝑋′, 𝐴′𝑧))] 𝐿𝐷𝑖𝑠(𝜙, 𝜆, 𝑋, 𝐴, 𝑧) = − log 𝐷𝑖𝑠𝜆(𝑧) − log (1 − 𝐷𝑖𝑠𝜆 (𝐸𝜙(𝑋, 𝐴))) 𝐿𝐸𝑛𝑐(𝜙, 𝜆, 𝑋, 𝐴, 𝑧) = − log 𝐷𝑖𝑠𝜆 (𝐸𝜙(𝑋, 𝐴)) 𝜇(𝑧) = 𝑒𝑥𝑝 ( 2 −(<𝑧,𝑧> −𝜅−1) 2𝜁2 ) (5) (6) (7) (8) 4 Experimental Result 4.1 UbiqLog (smartphone lifelogging) dataset In this paper, we test the life log data provided by UCI machine learning repository [15]. The open source UbiqLog application is used to generate the UbiqLog dataset. This application is based on the participant's smartphone and has collected lifelogging data for at least two months from each participant. The data collection process was conducted in 2013 and 2014 for 35 participants. The UbiqLog dataset consists of seven sensors such as WiFi, Location, SMS, Call, Application Usage, Bluetooth Proximity, and Activity State and contains a total of 9,782,222 instances. All records contain high- level symbols and are human-readable. It has gender, user label. Figure 4. graph visualization using JS 4.2 Graph Visualization To demonstrate that the data is well represented in the graph according to the de- signed semantics, we have created a graph visualization tool using Java Script (JS). Figure 4 shows an example plotting a graph using a visualization tool. In Figure 4, the black node represents the time node, the red node represents the source node, and the cyan node represents the sensor node. The thickness of the edge indicates the degree of connection. The proposed semantic network obtains time nodes every 15 minutes. Through this, it is possible to efficiently store an event occurring during a day using only a small memory space. It also provides additional information to the user's behav- ioral pattern analysis by placing a weight on the edge. Figure 5. t-SNE result of latent space with different label (left: sex, right: index) Label Sex (2 class) Index (32 class) Table 3. Classification accuracy with fixed encoder CCM-AAE 78.05% ± 1.1% 15.42% ± 2.43% AE 70.65% ± 2.56% 5.50% ± 1.20% 4.3 Pattern Analyzation In this section, we analyze the pattern of users in the dataset using the latent space formed by the learned encoder. For latent space analysis, we plotted the t-SNE for the latent variable. The two t-SNEs in Figure 5 are the same but reflect different labels (sex, human index). As a result, users' behaviors were classified into five patterns. In addi- tion, these patterns are subdivided into patterns that most users have in common (red circle), patterns that are revealed in specific genders (green circle), and patterns that are revealed in specific users (blue circle). These results suggest that the proposed frame- work can be used in various ways. For example, a pattern corresponding to each cluster may be analyzed to provide a customized service targeting a specific user, a specific gender, or general users. However, the analysis of the pattern corresponding to each cluster was excluded because it did not fit the scope of this study. Finally, we measure the accuracy by creating a deep classifier using fixed encoders. As shown in Table 3, the method used in this study showed better classification perfor- mance than the conventional AE. This indicates that CCM-AAE, a model used in our framework, can represent better graph features than basic AE. 5 Conclusion and Future work In this paper, we propose a graph pattern analyzation framework for lifelog data. This framework can generate graphs that efficiently store daily lifelogs and embed the generated graphs to organize users' patterns. It also facilitates lifelog analysis through latent space analysis. However, the daily graph can reduce the degree of information intensification due to severe fluctuations of size and inevitably mixed noises. Therefore, as a future study, we plan to study a framework that can extract subgraphs of daily graph and embed subgraphs to latent space. References 1. M. W. Lee, A. M. Khan, and T. S. Kim, "A single tri-axial accelerometer-based real-time personal life log system capable of human activity recognition and exercise information generation, " Personal and Ubiquitous Computing, vol. 15, no. 8, pp. 887-898, 2011. 2. Ö . Yürür, C. H. Liu, Z. Sheng, V. C. Leung, W. Moreno, and K. K. Leung, "Context-aware- ness for mobile sensing: A survey and future directions." IEEE Communications Surveys & Tutorials, vol. 18, no. 1, pp. 68-93, 2016. 3. J. Ø rmen, and A. M. Thorhauge, "Smartphone log data in a qualitative perspective, " Mobile Media & Communication, vol. 3 no. 3, pp. 335-350, 2015. 4. C. Gurrin, A. F. Smeaton, and A. R. Doherty, "Lifelogging: Personal big data, " Foundations and Trends in Information Retrieval, vol. 8, no. 1, pp.1-125, 2014. 5. V. C. Storey, and I. Y. Song, "Big data technologies and management: What conceptual modeling can do," Data & Knowledge Engineering, vol. 108, pp. 50-67, 2017. 6. A.Shimojo, S.Matsumoto, and M.Nakamura, "Implementing and evaluating life-log mashup platform using rdb and web services, " In Proc. of the Int. Conf. on Information Integration and Web-based Applications and Services, pp. 503-506, 2011. 7. W. V. Sujansky, S. A. Faus, E. Stone, and P. F. Brennan, "A method to implement fine- grained access control for personal health records through standard relational database que- ries, " Journal of biomedical informatics, vol. 43, no. 5, pp. 46-50, 2010. 8. J. Gemmell, G. Bell, and R. Lueder, "MyLifeBits: a personal database for everything, " Communications of the ACM, vol. 49, no. 1, pp.88-95, 2006. 9. H. H., Kim, S. Y., Lee, S. Y., Baik, & J. H. Kim, MELLO: medical lifelog ontology for data terms from self-tracking and lifelog devices. International journal of medical informat- ics, 84(12), (2015). 1099-1110. 10. H. Xu, & S. B. Cho, "An Effective Retrieval Method with Semantic Networks for Mobile Life-Log of Smartphones, " In International Conference on Neural Information Processing, pp. 753-760, 2013. 11. S. Lee, G.Gong, I. Hwang, and S. G. Lee, "LifeLogOn: A practical lifelog system for build- ing and exploiting lifelog ontology, " In International Conference on Sensor Networks, Ubiquitous, and Trustworthy Computing, pp. 367-373, 2010. 12. D. Grattarola, D. Zambon, C. Alippi and L. Livi, "Learning graph embeddings on constant- curvature manifolds for change detection in graph streams," arXiv:1805.06299, 2018. 13. T. N. Kipf, and M. Welling, "Semi-supervised classification with graph convolutional net- works," arXiv preprint arXiv:1609.02907, 2016 14. A. Makhzani, J. Shlens, N. Jaitly, I. Goodfellow, and B. Frey, "Adversarial autoencoders," arXiv preprint arXiv:1511.05644, 2015. 15. R. Rawassizadeh, E. Momeni, C. Dobbins, J. Gharibshah, and M. Pazzani, "Scalable daily human behavioral pattern mining from multivariate temporal data," IEEE Transactions on Knowledge and Data Engineering, vol. 28, no. 11, pp. 3098-3112, 2016.
1811.12809
1
1811
2018-10-28T03:37:44
Computing Vertex Centrality Measures in Massive Real Networks with a Neural Learning Model
[ "cs.SI", "cs.LG", "cs.NE", "cs.NI", "stat.ML" ]
Vertex centrality measures are a multi-purpose analysis tool, commonly used in many application environments to retrieve information and unveil knowledge from the graphs and network structural properties. However, the algorithms of such metrics are expensive in terms of computational resources when running real-time applications or massive real world networks. Thus, approximation techniques have been developed and used to compute the measures in such scenarios. In this paper, we demonstrate and analyze the use of neural network learning algorithms to tackle such task and compare their performance in terms of solution quality and computation time with other techniques from the literature. Our work offers several contributions. We highlight both the pros and cons of approximating centralities though neural learning. By empirical means and statistics, we then show that the regression model generated with a feedforward neural networks trained by the Levenberg-Marquardt algorithm is not only the best option considering computational resources, but also achieves the best solution quality for relevant applications and large-scale networks. Keywords: Vertex Centrality Measures, Neural Networks, Complex Network Models, Machine Learning, Regression Model
cs.SI
cs
Computing Vertex Centrality Measures in Massive Real Networks with a Neural Learning Model Federal University of Rio Grande do Sul Felipe Grando Institute of Informatics Porto Alegre, Brazil [email protected] Federal University of Rio Grande do Sul Luís C. Lamb Institute of Informatics Porto Alegre, Brazil [email protected] Abstract -- Vertex centrality measures are a multi-purpose analysis tool, commonly used in many application environments to retrieve information and unveil knowledge from the graphs and network structural properties. However, the algorithms of such metrics are expensive in terms of computational resources when running real-time applications or massive real world networks. Thus, approximation techniques have been developed and used to compute the measures in such scenarios. In this paper, we demonstrate and analyze the use of neural network learning algorithms to tackle such task and compare their performance in terms of solution quality and computation time with other techniques from the literature. Our work offers several contributions. We highlight both the pros and cons of approximating centralities though neural learning. By empirical means and statistics, we then show that the regression model generated with a feedforward neural networks trained by the Levenberg-Marquardt algorithm is not only the best option considering computational resources, but also achieves the best solution quality large-scale networks. for relevant applications and Keywords -- Vertex Centrality Measures, Neural Networks, Complex Network Models, Machine Learning, Regression Model I. INTRODUCTION The increasing development and ubiquity of large-scale networks poses several technological challenges for both researchers and professionals. Network digital and physical connections such as digital links between webpages, friend lists on social networks, wireless vehicular networks, cable connection between routers, streets paths and energy grids raise a growing number of complex questions. As a result, analyzing and understanding network properties is fundamental in several application domains [1] [2]. Therefore, the development of network analysis tools that provide information about the large number of existing networks is clearly relevant [3] [4]. One particular class of metrics known as vertex centrality are particular relevant, given their general applicability. Such metrics and associated algorithms aim at evaluating, ranking and identifying the importance of vertices (elements of a given network) using only the network basic structural properties as input information [5]. Centrality measures have been used in many areas over the last years, including: computer networks [6] [7], complex construction networks intelligence applications [10] [11], social network analysis [12] [13], traffic and transport flow [14] [16], game theory, problem-solving [17][18][19] and biology [20] [21]. artificial [8] [9], However, some of these metrics are computationally expensive even when their algorithms are polynomial in time; this is due to their use in massive networks with millions or even billions of vertices [22]. To tackle such complexity, we apply and experiment with a methodology that uses a complex network model and machine to approximate two of the mostly used centrality measures (namely, betweenness and closeness centralities) in real world networks. Further, we use as input the information provided by two other centrality measures (degree and eigenvector). techniques learning In order to obtain training samples for the neural learning step, we use the Block Two-Level Erdős and Rényi -- BTER [23] [24] generative network model. By using the BTER model, one can generate networks with diminished size, but with the same structural properties of massive real networks. The data obtained with the BTER synthetic networks is proven effective in training the neural network model, which is then able to generalize for the real datasets. In the coming sections, we also identify the appropriate combination of meta-parameters for an optimized learning process, including insights about the best options for neural network structure, training algorithm, multitasking and training information. In this paper, we illustrate the effectiveness of the proposed method on thirty real world scenarios comprising networks with sizes ranging from thousands to hundreds of thousand vertices. Finally, we compare the results of the neural learning model with other approximation techniques and with the exact computation of the centrality values. We show how the machine learning methodology is considerably faster than the others are and - at the same time -- we show that it renders competitive in comparable quality with other approximations methods, but not in all experiments. results The remainder of our paper is organized as follows. First, we introduce centrality measures, complex network models and related work in Section II. In Section III we explain our methodology and experimental analysis. Section IV concludes and points out future research avenues. 10.1109/IJCNN.2018.8489690 Version Accepted at IEEE 2018 International Joint Conference on Neural Networks (IJCNN) ©2018 IEEE II. BACKGROUND AND RELATED WORK A. Centrality Measures: A Summary In a nutshell, centrality measures quantify the centrality of each vertex of a network, usually creating a rank of vertices, or the entire network itself, by computing how centralized a given network is [3] [5]. The term centrality in this context can admit several meanings depending on the application domain under analysis. It may stand for power, influence, control, visibility, independency and/or contribution for instance [1] [3] [4] [5]. The vertex centrality measures are important to identify elements behavior and roles within a network and are usually employed to create ranks among vertices that are used as comparison factors with others domain specific metrics [3] [4]. Such metrics are characterized by deterministic algorithms. Each algorithm tries to capture a distinct idea or concept of "centrality of a vertex". Each algorithm and measure are distinct from the others although they frequently share a common goal and produce similar/close results. Some of these metrics are adaptations from the others to enable their use on digraphs or weighted networks [3]. In this work, we will use four centrality measures, namely: degree, eigenvector, betweenness and closeness. They are the most widely applied metrics and are some of the only metrics in which exact computation it is still possible for massive networks due to their lower complexity. This is important to allow our empirical and statistical analysis on massive networks within feasible time with resources available for our research (the experiments and further justifications are explained in detail in Section III). The centrality C of a vertex w can be computed with the formulas depicted in Table I. the algorithm Table I also shows time complexity considering a graph with n vertices and m edges. It is important to notice that although the complexity of eigenvector is quadratic there is a simpler computation method known as the power method, which that approximates the exact metric within few steps and avoids numerical accuracy issues [30]. is an iteration algorithm TABLE I. VERTEX CENTRALITY MEASURES FORMULAE Centrality Measure Formulae Algorithm Complexity Degree [5] Betweenness [25] [26] Closeness [27] [28] Eigenvector [29] [30] Θ(m) O(mn) O(mn) O(n2) a(i,w) admits value 1 when vertices i and w are adjacent; gij(w) is the number of shortest paths between vertices i and j that passes through w; d(i,w) is the length (distance) of the shortest path between vertices i and w; A is the adjacency matrix of a graph, E is the eigenvector (initialized with ones on iteration 1) and it is the current iteration. B. On Complex Network Models In complex networks research, one aims at understanding and proposing models and theories about the formation of real world networks and their structural properties. The field attracted a lot of attention recently, due to the high availability of large networks and connected knowledge bases. Such studies have aimed at understanding networks' common characteristics and at creating models capable of generating networks stochastically with similar properties. These models became a valuable research tool for many disciplines [1] [22]. Several complex network models were developed and studied over the last years. However, some of them are unable to capture and represent some properties of real networks, while others are only conceptualizations and unfortunately are not designed for generating synthetic networks [4] [22]. The Block Two-Level Erdős and Rényi (BTER) model [23] generates networks with very similar properties of real networks. It builds a network based on a desired degree distribution and clustering coefficients (average clustering for each set of vertices with same degree or the global clustering of the network). The BTER model is divided into three steps [24]: (i) the vertices are grouped by degree in communities with size equal to the degree of its members plus one; (ii) each community is considered an Erdős and Rényi graph [31] with a probability of connection among vertices equals to the clustering coefficient; (iii) connections among communities are generated proportionally to the excess degree of each vertex (number of connections that a vertex needs to match its desired degree). This weighted distribution is similar to the Chung and Lu graphs [32] [33]. C. On Approximating Centrality Measures Typical centrality measures algorithms do not scale up to massive graphs (such as large social networks and web graphs). This can be even more critical when one needs to compute many centrality queries, particularly when one is interested in the centrality of all vertices or whenever the network structure is dynamic in time. in which, Several authors address the high computational complexity of the centrality measures algorithms [34] [36]. They usually propose approximation techniques for specific network metrics based on sampling methodologies the exact computation of the metric is realized for sampled vertices and then is used as reference to estimate the centrality values of the others vertices of the network. For instance, the betweenness and closeness centralities share a quite similar foundation. One computes the single source shortest path (SSSP) for a given number of sample vertices. Each SSSP tree gives the exact centrality value for its source vertex. At the same time, one can use them as an approximation for the other vertices considering that all previously computed SSSP trees are partial solutions for such vertices. Therefore, a given vertex not sampled will have its centrality value approximated by an average result given by all SSSP trees from the sampled vertices. An algorithm for such objectives was defined and tested in real case scenarios by Bader et al. [34] for betweenness and by Eppstein and Wang [35] for closeness centralities. However, the simple approach given by the sampling technique has a few drawbacks and leads to relevant questioning such as: how many vertices should be sampled and how should one select them? Or, how can one efficiently parallelize the sampling technique considering that it is no longer possible to compute each vertex centrality independently? Brandes and Pich [36] studied the vertices selection problem. They proposed many heuristics to choose vertices for the sampling techniques, starting with simple ones, such as picking the high degree vertices and finishing with more complex ones, which consider vertices distances and mixed strategies. Despite their attempts to find an optimal heuristic for such problem, they concluded that picking vertices uniformly at random on average is the best strategy when considering different types of network structures. Some authors [22] [37] [38] tried other kind of approximation methodologies, based mainly on machine learning and neural networks. The strength of these methodologies is their adaptability (they can be used to approximate several distinct centrality measures) and they are able to compute the centrality measures a lot faster than any other method after the model is trained. The main problems with a neural machine learning approach are their configuration and training for this task. Complex network models were applied to generate synthetic networks providing plentiful training data for the training algorithm. However, one asks how and what is the best option to generate such networks? And, which attributes should be used to train the models? These are still open issues. In order to answer such questions, we put the ideas into a comprehensive experimentation. This will serve to illustrate the capabilities of the method in validation and comparative analyses. III. METHODOLOGY AND EMPIRICAL ANALYSIS The methodology applied in our experiments is divided in four main steps: (A) acquiring test (real world networks) and training data (synthetic networks generated with the BTER complex network model); (B) testing and validating the meta-parameters of the artificial neural networks and training algorithms; (C) computing the centrality measures using the exact algorithms, the model generated by the artificial neural network and the sampling-based algorithms in real networks; (D) comparing the results of the approximation techniques. A. Acquisition of Testing and Training Data The testing data was selected from four freely available data repositories: Stanford large network dataset collection, social computing data repository, BGU social networks security research group and the Klobenz network collection. The selected networks are symmetric and binary (unweighted edges). Only the largest connected component (LCC) was used for the tutorial experiments, which was computed for all analyzed networks. Thirty real networks were selected with sizes ranging from a thousand to 1.5 million vertices. The BTER complex network model was used to obtain enough and consistent training data. The BTER complex network model was chosen for such a task as it is one of the best models to reproduce real world networks structural properties. Moreover, it is easy to implement and configure and capable to generate plentiful networks with reduced size keeping the most relevant structural properties presented by massive networks. BTER requires two configuration parameters: the desired degree distribution and the clustering coefficient (which can be configured as a global value, by vertices degree or by community structure). In our experiments, we applied both a heavy-tailed and a lognormal distribution (parameters provided by [37] [44] [45]) as degree distribution to provide generic data to train and learn the model. Both distributions are known as the best representatives of most real networks degree distribution studied in the literature [44] [45]. For these networks the clustering coefficients were chosen at random in the interval [0,0.7]. A total of 300 generic networks with sizes ranging from a hundred to a thousand vertices were generated at this step. We also generated networks with the degree distributions of six real networks (described in Table II) with their respective clustering coefficients to test the effect of specific vs. generic training data in the machine learning model. These networks were selected as they presented the worst (Amazon, Euroroad, Facebook and PowerGrid networks) and the best (Blog3 and Foursquare networks) overall results obtained by the model trained with the generic training data amongst the thirty real networks selected. A transformation function (parameters estimated for each degree distribution using as reference a heavy-tailed function model) was applied in the degree distribution to reduce the size of the generated networks. A total of 2400 specific networks (400 for each set of parameters), half with 2000 vertices and half with 3000 vertices. TABLE II. REAL NETWORKS DESCRIPTION Network Amazon [39] Facebook [12] Blog Catalog 3 [40] Foursquare [40] Type Co-Purchasing Social Social Social US Power Grid [41] [42] Supply Lines Euroroad [42][43] Road Vertices 334,863 4,039 Edges 925,872 82,143 10,312 333,983 639,014 3,214,986 4,941 1,174 6,594 1,305 B. Parameters Configuration and Validation We applied the neural network toolbox from Matlab 2015 to configure and train the neural networks. This toolbox comprises most of the algorithms that are well established in the field with a built-in parallelism pool and a robust implementation for industrial, academic and research use. of Following the results in [37] and [38] we selected a fully- connected multi-layer perceptron artificial neural network trained by the Levenberg-Marquardt algorithm (LM) [47]. We tested a full set of combination of parameters with 10- fold cross-validation using the generic training set. The parameters tested were: number of neuron in each layer (from 2 to 100), number of hidden layers (from 1 to 5), the Marquardt adjustment (mu - from 5.10-6 to 5.10-3), mu decrease factor (from 0.1 to 1) and mu increase factor (from 1 to 25). Additionally, we set the activation function of all hidden layers to hyperbolic tangent (any sigmoid function would suffice for such task) and the activation function of the output layer as a linear function (due to the regression task in hand). The batch method was used to update the training parameters. Our objective here was to find out the most efficient its configuration computational costs and solution quality. The quality of the solution was measured by the determination coefficient (R²) using only the test set results, which considers 10% of total available training data. considering parameters both In addition, we also computed the Kendal τ-b correlation coefficient in order to evaluate the quality of the solution of the networks. The Kendall's correlation is a nonparametric measure of strength and association (interval [-1,1]) that exists between two variables measured on at least an ordinal scale. Notice that for most applications the ordering (rank) of the vertices by their centrality values is more important than the centrality value itself. Each centrality measure uses complex properties of the graph representing the network and the computation of most of these properties are the main reason that centrality measures are time expensive. For such reason, we selected the fastest centrality measures (degree and eigenvector), which are computationally feasible even for massive networks and are highly related to the other metrics [3]. Therefore, we computed both centralities (degree and eigenvector) and ranked the vertices. Such information is then used as input data to train the neural network. We select the vertices rank produced by betweenness and closeness centralities as desired values. In the experiments, a three-hidden layer network with 20 neurons in each layer achieved the best performance results (considering quality and training speed). Larger networks achieved equally good results in quality but at the expanse of more computational resources. Excluding the mu decrease factor that is optimal when configured inside the interval [0.1,0.5], the other parameters of the LM algorithm showed little influence on the overall results displaying no statistical relevance. This configuration was used for the final training of the artificial neural network. The final training used the same training data (the generic synthetic networks) but with 15% as validation set to prevent overfitting (the training algorithm stops when the performance does not improve in the validation set for ten consecutive batches). C. Computation of the Approximation Techniques In the sequel, we computed each of the four exact centrality measures (eigenvector -- CE, betweenness -- CB, closeness -- CC, and degree -- CD) for the thirty selected real networks. The computation of eigenvector and degree centralities is sequential, while betweenness and closeness centralities are computed simultaneously with a merged algorithm keeping the same time complexity upper bounds and using parallelism [28]. All algorithms were programmed in C and the parallel computations used the native OpenMP (Open Multi-Processing interface). The computation of the metrics used a SGI Altix Blade with 2 AMD Opteron 12-core 2.3GHz, 64GB DDR3 1333MHz RAM memory, Red Hat Enterprise Linux Server 5.4. The computation time of degree centrality required less than 1s to compute for all networks. Eigenvector centrality took at most 2min for the largest network, while betweenness and closeness centralities, even using 24 cores in a parallel environment, took 9 days for the largest network (Hyves). We adopted two sample sizes for each network: 2.5% and 5% of the number of total vertices for the computation of the sampling algorithms. The samples were uniformly randomized and five independent trials with distinct random seeds were executed for each sample size for each network. The computation of the approximation algorithm was run in the same machine, but in a sequential environment because it would require a larger number of dependent variables between different threads. However, the computation of both algorithms shared similar parts; their computation was simultaneous for performance largest network required almost 2 days for their computation with 5% sampled vertices and took about half for the 2.5% sample. improvement. The therefore, Next, we computed the centrality measures for all thirty real networks with the trained neural network model (Section III B) and used the Kendall correlation as quality parameter. The results showed a great majority of variability: the model performed poorly for some of the networks (Euroroad, Power Grid, Facebook and Amazon for instance) with coefficients lower than 0.4 and really well in others (Blog3 and Foursquare) with coefficients above 0.7. We think that this behavior is mainly caused by the data used during the training, which was generic for all networks and unable to fulfill specificities for some of the real networks. For such reason, we trained a specific neural network model for each of the six networks that presented the lower and higher results (Euroroad, Power Grid, Foursquare, Amazon, Blog3 and Facebook) with specific generated networks with the parameters provided by each of these networks (Section III A). We also tested multitasking neural networks capable of learning both centralities (closeness and betweenness) at the same time. Moreover, we tried to add another attribute for the training. In addition to the degree and eigenvector, we added a metric composed by the sum of the vertex degree with the degree of his neighbors (second level degree). The experiments comprised all the combinations of sizes of training set networks (2000 or 3000), three or just two attributes (addition second level degree or not) and the use of multitasking or not. We generated networks with the same size of the original network exclusively for the Euroroad real network due to its original size of less than 2000 vertices. To simplify the visualization of the comparative analysis we used the code NN (baseline) for the neural network model trained with the generic dataset and the code NNTAM for the model trained with the specific training set. T assumes value 2 for the networks with size 2000 and 3 for the size 3000, A assumes the quantity of attributes used (2 or 3) and M assumes 1 for simple tasking and 2 for multitasking networks. D. Comparative Analisis First, we have compared and analyzed the correlation values between the approximation methods. The sampling techniques performed better than all neural models tested but the difference is minimal is some cases. The neural models trained with generic networks performed considerably worse than the ones trained with the specific training set of networks excluding one case (Facebook network), where the generic model performed a little better. The difference among the neural models is greater on networks where the first model performed worse. Amongst the parameters tested, we noticed that the size of the specific networks used for training the model was statistically irrelevant for the results. This was also true in most cases for the multitasking. The addition of a third attribute seems the overall performance when approximating the closeness centrality, but sometimes it is harmful to approximate betweenness. to contribute for Tables III and IV summarizes the correlation results of some of the combinations tested with best neural network model for each network highlighted in gray. The other tests (3xx and 231) were omitted because they generated results similar to their counterparts. TABLE III. CORRELATIONS COEFFICIENTS FOR BETWEENNESS Approximation Technique Network Sample Amazon Blog3 Euroroad Facebook 2.5% 0.91 0.89 0.86 0.67 Foursquare 0.89 PowerGrid 0.93 5.0% NN 0.91 0.27 Neural Network Model 211 222 0.26 0.35 212 0.32 221 0.26 0.90 0.88 0.75 0.92 0.92 0.73 0.16 0.36 0.73 0.21 0.80 0.41 0.30 0.75 0.57 0.80 0.41 0.35 0.72 0.51 0.71 0.44 0.24 0.66 0.43 0.70 0.44 0.20 0.66 0.42 232 0.27 0.71 0.46 0.29 0.68 0.45 TABLE IV. CORRELATION COEFFICIENTS FOR CLOSENESS Approximation Technique Network Sample Amazon Blog3 Euroroad Facebook 2.5% 0.99 0.95 0.87 0.87 Foursquare 0.93 PowerGrid 0.90 5.0% NN 0.99 0.10 0.96 0.90 0.93 0.94 0.93 0.69 0.09 0.26 0.48 0.12 Neural Network Model 222 211 0.42 0.65 212 0.52 221 0.66 0.89 0.60 0.38 0.85 0.03 0.89 0.60 0.34 0.84 0.14 0.92 0.62 0.35 0.88 0.26 0.93 0.62 0.36 0.88 0.26 232 0.65 0.93 0.62 0.43 0.88 0.24 Table V compares the mean determination coefficient (R²) of the NN baseline model with models generated with the same training data but with other machine learning algorithms using 10-fold cross-validation. Notice that even small differences in the R² are considerable due to large amount of data. We also see that the NN model performed consistently better than all other methods considering that the 99% confidence intervals for all algorithms lie on the fourth decimal place. TABLE V. REAL NETWORKS DESCRIPTION Algorithm NN Linear Regression Coarse Tree Gaussian SVM R² Closeness Betweenness 0.97 0.95 0.95 0.96 0.92 0.87 0.89 0.88 Next, we computed and analyzed the percentage of correctly classified vertices by their rank considering percentile sets of the network. For this analysis, we ordered the vertices by their exact centrality values, divided such set of vertices in percentiles (from 0.2% of the first ranked vertices to the first 25% vertices), and computed the percentage of these vertices for each percentile that appears in the same percentile in each one of the approximations techniques ranked the vertices. A 100% match means that every element from one set is on the other (perfect classification), while 0% means that both sets are completely disjoint. Such kind of analysis is important to give us an idea of how close/distant the rankings of the vertices are considering only the more important vertices of the network (generally speaking, the ones of interest for most applications). It also shows us better and gives insights "where" the mistakes are, fact that is obscured when considering only the correlation coefficients. Figure 1 compares the results of the approximation methodologies for each network. Only the best approximation techniques (5% sample and best neural models) are showed to facilitate the reading of the figures. We already expected that the sampling-based the machine learning models simply because they have access to more information about the overall network structure with the techniques performs better than drawback of requiring a lot more of computation time to acquire such information. network structure while in the other networks more complex information is needed. We can see that the Blog3 network was the only case scenario where the neural models performed as good as or a little better that the sampling methodologies. The Blog3 network probably has a simpler structure, therefore the information contained the Degree and Eigenvector centralities (used as training inputs) fully characterize the in One should also consider that the neural learning model is capable to compute the centrality for all vertices of a given network in seconds (even for massive networks) and that the sampling techniques takes at least some minutes for the smaller networks and hours or even days for the biggest networks. Fig. 1. Percentage of correct classified vertices by percentil set of the network Fig. 2. Comparison between different sampling sizes In addition, the NN232 configuration seems better than the other NN architectures to rank the first 25% ranked vertices except for betweenness centrality in Foursquare network and for both centralities in Facebook network. Figure 2 presents the effect of different sampling sizes considering the mean results over the six networks analyzed. It only reinforces what the correlation values already show (Tables III and IV). The upgrade in solution quality for the 5% sample is minimal comparing that it costs twice in terms of computational time. The growing IV. CONCLUSIONS relevance of network research and applications demand the development of appropriate tools and methods for network analysis. These methods include vertex centrality measures. However, as networks grow in size, their computational costs present challenges which may hinder some important applications. Machine learning techniques have recently been successful in a number of relevant applications tackling large amounts of data [46] [47] [48]. Moreover, the referred growing availability of massive network databases demands the use of effective techniques to better exploit and to interpret this context, we presented a comprehensive empirical analysis on the use of artificial neural networks learning to estimate centrality measures. We have these data. In tested and identified the best configuration for the artificial neural network training, including network structure, training algorithm, and training meta-parameters. The experimental results revealed that the neural network model is able to approximate the target centrality measures with considerable accuracy and reduced computational costs in 30 real-world experimental case scenarios. Our research also shows that the data used for training the model is one major factor that affects the learning model. In the real world experiments where generated networks with specific parameters were applied during the training, the performance of the neural model improved considerably. Considering this result, one should always use the knowledge (degree distribution and clustering coefficients) about the network of interest to generate specialized training data; this will lead to improvements in the performance of the artificial neural learning model. The model showed a noticeable and clear advantage and tradeoff with respect to computational costs, making it a viable option for applications where accuracy is not the only fundamental goal, but in scenarios and configurations in which computation resources are limited. In such common situations, approximations via machine learning are an effective alternative, in particular in the context of large scale complex network applications. REFERENCES [1] D. Easley and J. Kleinberg. Networks, Crowds, and Markets: Reasoning About a Highly Connected World. Cambridge University Press, 2010. [2] S. Yu, M. Liu, W. Dou, X. Liu, Sanming Zhou: Networking for Big Data: A Survey. IEEE Comm. Surv. & Tut., 19(1): 531-549, 2017. [3] F. Grando, D. Noble, and L. C. Lamb, "An analysis of centrality measures for complex and social networks", Proc. of IEEE Global Communications Conference, 1-6, 2016. [4] L. F. Costa, F. A. Rodrigues, G. Travieso and P. R. Villas Boas, "Characterization of complex networks: a survey of measurements", Advances in Physics, 56:167-242, 2008. [5] L. C. Freeman, "Centrality in social networks: conceptual clarification", Social Network, 1:215-239, 1978/79. [6] L. Maccari, Q. Nguyen, and R. L. Cigno, "On the computation of centrality metrics for network security in mesh networks", Proc. of the Global Communications Conference, 1-6, 2016. [7] P. Pantazopoulos, M. Karaliopoulos, and I. Stavrakakis, "Distributed placement of autonomic internet services", IEEE Transactions on Parallel and Distributed Systems, 25(7):11702-1712, 2014. [8] M. König, C. Tessone and Y. Zenou, "Nestedness in networks: a theoretical model and some applications", Theoretical Economics, 9:695-752, 2014. [9] M. E. J. Newman, and M. Girvan, "Finding and evaluating community structure in networks", Physical Review E, 69(2):026113, 2004. [10] P. Kazieenko, T. Kajdanowicz, "Label-dependent node classification in the network", Neurocomputing, 75(1):199-209, 2012. [11] X. Cao, L. Wang, B. Ning, Y. Yuan, and P. Yan, "Pedestrian detection scenes by dynamically updating visual words", in unseen Neurocomputing, 119:232-242, 2013. [12] J. Mcauley and J. Leskovec, "Learning to discover social circles in ego networks", Proc. NIPS, 2012. [13] X. Li, Y. Liu, Y. Jiang, and X. Liu, "Identifying social influence in complex networks: a novel conductance eigenvector centrality model", Neurocomputing, 210:141-154, 2016. [14] A. Jayasinghe, K. Sano and H. Nishiuchi, "Explaining traffic flow patterns using centrality measures", International Journal for Traffic and Transport Engineering, 5(2):134-149, 2015. [15] P. X. Zhao and S. M. Zhao, "Understanding urban traffic flow characteristics from the network centrality perspective at different granularities", Intern. Archives of the Photogrammetry, Remote Sensing and Spatial Information Sciences, XLI-B2:263-268, 2016. [16] S. Gao, Y. Wang, Y. Gao and Y. Liu, "Understanding urban traffic-flow characteristics: a rethinking of betweenness centrality", Environment and Planning B: 40(1):135-153, 2013. [17] D. Noble, F. Grando, R. M. Araújo, and L. C. Lamb, "The impact of centrality on individual and collective performance in social problem- solving systems", Proc. GECCO, 2015. [18] D.V. Noble, M.O.R. Prates, Daniel Bossle, Luís C. Lamb: "Collaboration in Social Problem-Solving: When Diversity Trumps Network Efficiency". AAAI 2015: 1277-1283. [19] T. P. Michalak, K. V. Aadithya, P. L. Szczepański, B. Ravindran, and N. R. Jennings, "Efficient computation of the Shapley value for game- theoretic network centrality", JAIR, 46:607-650, 2013. [20] M. P. van den Heuvel and O. Sporns, "Network hubs in human brain", Trends in Cognitive Sciences, 17(12):683-696, 2013. [21] W. Xiong, L. Xie, S. Zhou and J. Guan, "Active learning for protein networks", protein-protein interaction function Neurocomputing, 145:44-52, 2014. prediction in [22] F. Grando, L.C. Lamb. On approximating networks centrality measures via neural learning algorithms. "Proc. of the IEEE International Joint Conference on Neural Networks - IJCNN". 1-7, 2016. [23] C. Seshadhri, T. G. Kolda, and A. Pinar, "Community structure and scale-free collections of Erdős-Rényi graphs", Physical Review E, 85(5):056109, 2012. [24] T. G. Kolda, A. Pinar, T. Plantenga and C. Seshadhri, "A scalable generative graph model with community structure", SIAM Journal on Scientific Computing, 36(5):424-452, 2014. [25] L. C. Freeman, "A set of measures of centrality based on betweenness", Sociometry, 40:35-41, 1977. [26] U. Brandes, "A faster algorithm for betweenness centrality", Journal of Mathematical Sociology, 25:163-177, 2001. [27] G. Sabidussi, "The centrality index of a graph", Psychometrika, 31:581- 603, 1966. [28] U. Brandes, "On variants of shortest-pat betweenness centrality and their generic computation", Social Networks, 30:136-145, 2008. [29] P. Bonacich, "Factoring and weighting approaches to status scores and clique identification", Journal of Math Sociology, 2:113-120, 1972. [30] W. Richards and A. Seary, "Eigen analysis of networks", Journal of Social Structure, 1, 2000. [31] Erdős, P.; Rényi, A.. On Mathematicae". 6:290-297, 1959. random graphs I. "Publicationes [32] Chung, F.; Lu, L.. Connected components in random graphs with given degree sequences. "Annals of Combinatorics". 6:125, 2002. [33] Chung, F.; Lu, L.. "The average distances in random graphs with given expected degrees". PNAS, 99:15879, 2002. [34] D A. Bader, S. Kintali, K. Madduri and M. Mihail, "Approximating betweenness centrality", Proc. Of the 5th International Conference on Algorithms and Models for the Web-Graph, 124-137, 2007. [35] D. Eppstein and J. Wang, "Approximating centrality", Journal of Graph Algorithms and Applications, 8(1):39-45, 2004. [36] U. Brandes and C. Pich, "Centrality estimation in large networks", International Journal of Bifurcation and Chaos, 17(7):1-30, 2007. [37] F. Grando and L. C. Lamb, "Estimating complex networks centrality via neural networks and machine learning", Proc. of the International Joint Conference on Neural Networks (IJCNN-2015), 1-8, 2015. [38] A. Kumar, K. G. Mehrotra and C. K. Mohan, "Neural networks for fast estimation of social network centrality measures", Proc. FANCCO, 175- 184, 2015. [39] J. Yang and J. Leskovec, "Defining and evaluating network communities based on ground-truth", Proc. of the IEEE ICDM, 2012. [40] R. Zafarani and H. Liu, "Social computing data repository at ASU", Arizona State University, School of Computing, informatics and Decision Systems Engineering, 2009. [41] D. J. Watts and S. H. Strogatz, "Collective dynamics of 'small-world' networks", Nature, 393(6684):440-442, 1998. [42] Network Dataset, KONECT, at http://konect.uni-koblenz.de/, 2016. [43] L. Šubelj and M. Bajec, "Robust network community detection using balanced propagation", The European Physical Journal J. B., 81(3):353- 362, 2011. [44] S. Boccaletti, V. Latora, Y. Moreno, M. Chavez, and D-U. Hwang, "Complex networks: Structure and dynamics", Physics Reports, 424:175-308, 2006. [45] M. Mitzenmacher, "A brief history of generative models for power law and lognormal distributions", Internet Mathematics, 1(2):226-251, 2003. [46] A. Garcez, L. de Raedt, L.C. Lamb, R. Miikkulainen, P. Hitzler, T. Icard, T. Besold, P. Foldiak, D. Silver and K. Kuehnberger. "Neural- Symbolic Learning and Reasoning: Contributions and Challenges", Proc. AAAI Spring Symposium on Knowledge Representation and Reasoning: Integrating Symbolic and Neural Approaches, Stanford, pp. 18-21, AAAI Press, 2015 [47] Hagan, M. T.; Menhaj, M.. Training feed-forward networks with the Marquardt algorithm. "IEEE Transactions on Neural Networks". 5(6):989-993, 1994. [48] Y. LeCun, Y. Bengio and G.E. Hinton. Deep Learning. Nature 521:14539, May 2015.
1608.01709
1
1608
2016-08-04T21:58:21
Robustness and Resilience of cities around the world
[ "cs.SI", "physics.soc-ph" ]
The concept of city or urban resilience has emerged as one of the key challenges for the next decades. As a consequence, institutions like the United Nations or Rockefeller Foundation have embraced initiatives that increase or improve it. These efforts translate into funded programs both for action on the ground and to develop quantification of resilience, under the for of an index. Ironically, on the academic side there is no clear consensus regarding how resilience should be quantified, or what it exactly refers to in the urban context. Here we attempt to link both extremes providing an example of how to exploit large, publicly available, worldwide urban datasets, to produce objective insight into one of the possible dimensions of urban resilience. We do so via well-established methods in complexity science, such as percolation theory --which has a long tradition at providing valuable information on the vulnerability in complex systems. Our findings uncover large differences among studied cities, both regarding their infrastructural fragility and the imbalances in the distribution of critical services.
cs.SI
cs
Robustness and Resilience of cities around the world Sofiane Abbar†, Tahar Zanouda †, Javier Borge-Holthoefer‡ †Qatar Computing Research Institute, Hamad Bin Khalifa University ‡Internet Interdisciplinary Institute (IN3-UOC), Universitat Oberta de Catalunya PO 5825, Doha, Qatar 08018 Barcelona, Catalonia, Spain {sabbar, tzanouda}@qf.org.qa, [email protected] ABSTRACT The concept of city or urban resilience has emerged as one of the key challenges for the next decades. As a con- sequence, institutions like the United Nations or Rock- efeller Foundation have embraced initiatives that in- crease or improve it. These efforts translate into funded programs both for action"on the ground"and to develop quantification of resilience, under the for of an index. Ironically, on the academic side there is no clear con- sensus regarding how resilience should be quantified, or what it exactly refers to in the urban context. Here we attempt to link both extremes providing an example of how to exploit large, publicly available, worldwide urban datasets, to produce objective insight into one of the possible dimensions of urban resilience. We do so via well-established methods in complexity science, such as percolation theory -- which has a long tradition at providing valuable information on the vulnerability in complex systems. Our findings uncover large differ- ences among studied cities, both regarding their infras- tructural fragility and the imbalances in the distribution of critical services. Keywords Complex Networks, City resilience, City Robustness, Percolation Copyright is held by the author/owner(s). UrbComp'16, August 14, 2016, San Francisco, USA. 1. INTRODUCTION Over the past years the concept of urban or city resilience has repeatedly appeared in many contexts. While there is a general agreement that it is related to the capacity of a urban area to confront uncertainty and/or risk, it is not clear how it should be operational- ized or quantified. Meerow et al. [12] identify as many as 25 different definitions of urban resilience in the liter- ature, related more or less strictly to Engineering, En- vironmental Sciences, Business and Finance, or Social Sciences. Indeed, it seems common sense that "generic resilience" (capacity of a system to recover its initial state after a shock) can be mapped onto a myriad of particular definitions which differ only in the number of affected subsystems (infrastructural, social, ecologi- cal) and the time scale of the disturbance itself: a shock may arrive under the form of a natural disaster (fast, system-wide), an economic crisis (slow, specific) or the long-term urban footprint on the surrounding environ- ment (very slow and hardly visible in the city itself). These semantic difficulties go well beyond pure academia, and can affect actual efforts towards increas- ing urban resilience. Public and private institutions, like the United Nations or the Rockefeller Foundation, are currently supporting initiatives which focus, explic- itly or implicitly, on this topic. If, however, its defi- nition is unclear, these programs encounter difficulties at making decisions -- whether a given investment makes sense or not. In this direction, the "100 Resilient Cities Program" (100RC) at the Rockefeller Foundation has recently released some guidelines with regard to what makes a city resilient (City Resilience Index, CRI)1. This effort to build an agreed rationale is interesting, because it breaks down the problem into four dimen- sions (see Figure 1), which is already a significant ad- 1See http://www.cityresilienceindex.org/ Figure 1: Guidelines to the CRI. Resilience is mapped onto 4 key dimensions (outmost ring), which are in turn subdivided into 12 specific goals. vance toward operationalization. In this paper we focus on the infrastructural side of the 100RC, which breaks this dimension into three goals: reliable mobility and communications; reduced exposure and fragility; and effective provision of critical services. We relate each of these goals to different as- pects of network robustness, which has a longstanding tradition in complex systems, and percolation theory in particular [1, 5, 7]. Our claim is that the current avail- ability of large digital datasets, and of solid foundations in complex networks can offer a suitable quantitative complement to the evaluation of city resilience, which -- as in the example of CRI -- typically relies on general traits (e.g. exposure of a zone to flooding hazards). Our study relates the first aforementioned goal with the robustness of the road network against random fail- ure of its segments, inasmuch "reliable mobility" re- lates to daily connectivity between places, people and services. In this sense, the network is prone to fail anywhere, anytime (accidents, congestion, system-wide shocks), as opposed to targeted attacks on critical parts of the infrastructure which is the second goal ("reduced exposure and fragility"). Finally, we combine this net- work approach with large datasets on service location extracted from Foursquare 2 -- a location-based social network (LBSN) -- to understand to what extent a bro- ken infrastructure can affect the reachability of critical services ("effective provision of critical services"), i.e. whether a city offers a balanced and redundant supply of resources. Such services include but are not limited to "medical center" and "transportation infrastructure". In order to place the paper in the right context, we Figure 2: The geography of cities covered in this study. As we see, cities are from around the world and span six continents. have chosen to perform this work mostly on cities in- cluded in 100RC for which we could collected data, of- fering a study at scale which allows for a cross-city ro- bustness comparison that has -- to the best of our knowledge -- not been addressed before. 2. DATA To conduct our study, we focus on cities participating in the 100RC program to which we deliberately added 5 cities from the Gulf Cooperation Council (GCC) in the Middle East. These cities are Abu-Dhabi and Dubai (UAE), Doha (Qatar), Manama (Bahrain), and Riyadh (Saudi Arabia). Figure 2 gives an overview of the ge- ographical distribution of the 54 cities considered. We can easily see that the cities span all continents (ex- cept Antarctic) with 4 cities from Africa, 14 from Asia, 10 from Europe, 14 from North America, 6 from South America, 1 from Central America, and 4 from Oceania. The geographic diversity and cultural heterogeneity of these cities provide two advantages. First, it dimin- ishes the biases one could observe in studies that focus on cities from a particular country or continent. Fur- thermore, it allows a more robust generalization of the findings. For each city, we requested two types of data: the road network and the geographic distribution of differ- ent services available in the city. We describe in the following section the data used and the processes by which it was prepared. We also report some initial ob- servations. 2.1 From Open Street Map to Road Net- works OpenStreetMap (OSM) 3 is a popular open source mapping service built by a community of volunteer map- pers who contribute to the tagging of cities by maintain- ing data about buildings, shops, roads, metro stations and any other service that has a value to be on a map. As a crowd-sourced platform, OSM relies on its active 2https://foursquare.com/ 3http://www.openstreetmap.org community of contributers to create accurate maps by leveraging their local knowledge on neighborhoods. Be- cause OSM databases are exclusively contributed by volunteers, it is important to understand that its ac- curacy and completeness vary from a city to another. Generally speaking, large touristic cities like Paris, New York, and Singapore tend to expose data with high res- olution and quality as compared to smaller and isolated cities. While OSM provides reasonable APIs to query its databases, we decided to use a more comprehensive on- line service called Mapzen4 to download "extracts" of relevant cities. The extracts we requested come in the form of shape files that are easy to process. Mapzen updates on a daily basis its city extracts by querying OSM. 2.2 Creating road networks The shape file of cities come with different files defin- ing different services in the city such as transport points, building, places, administrative boundaries, and roads. All these objects are made in OSM with nodes. A node is defined with two mandatory attributes that are its I D (unique identifier) and its GPS coordinates (longi- tude, latitude), and a list of complementary information such as names, addresses, and types of locations. Com- plex objects such as buildings are defined as polygons of nodes whereas paths (segments of roads) are defined as lists of nodes. Given the road shape file (i.e., list of paths) of a city, our objective is to create a real road network in which nodes are intersections and edges are road segments be- tween them. The major challenge in this task is to know how to merge different paths (streets) into the same transportation unit (road). Different techniques have been proposed in the literature to deal with this problem. Some of them rely on the street names (SN) to group them [9] whereas other methods are based on the geometry of streets and look at the intersection con- tinuity between streets (ICN) [13]. Given that both ap- proaches have pros and cons, we decided to go with our own three-steps heuristic (see Figure 3 for an illustrative example.) Step 1. We identify the list of relevant nodes. A node is considered relevant to the road network if and only if it verifies one of the following two conditions: (i.) The node is the beginning or the end of a path. (ii.) The node belongs to more than one path. The first condition captures all nodes necessary to the def- inition of roads whereas the second condition captures intersections between roads. Step 2. We iteratively scan through the list of all paths available in the city shape file. For each path, we create an edge between every successive pair of relevant nodes identified in step one. This process discards in- termediate nodes that OSM mappers use primarily to 4http://mapzen.com Figure 3: Building road network from OSM paths. Given three roads, we first identify the set of relevant nodes. Nodes number 1, 3, 4, 6, 7 and 9 are relevant because they start/end roads. Nodes 4 and 6 are also intersections as both belong to more than one path. But node 4 is removed in the third step at it holds a degree k = 2. (a) New York (b) London (c) Dakar (d) Dubai Figure 4: Road networks of some selected cities as extracted from OpenStreetMap. We see that cities show different types of networks in terms of size, density, and topology shape road segments. Step 3. We recursively prune from the resulting graph all nodes with degree k = 2 and replace them with an edge connecting the two nodes to which they are linked. The intuition here is that nodes with degree k = 2 do not add any semantic to the road network as it is envisioned in this study. Examples of real road networks of four cities gener- ated with our heuristic are shown in Figure 4. In Table 1 we summarize some key structural traits of the extracted road networks. For consistency reason, we reduce the road network of each city to its first gi- ant connected component (GCC) for which we highlight V (city) (number of nodes), E(city) (number of edges), Length (total kilometers), average degree (k). We in- clude also Meshness M ∈ [0, 1], defined as the ratio of the existing facets divided by the total number of all 123445614698679714697Input. 3 OSM pathsStep1. Relevant nodesStep 2. Relevant edges1697Step 3. Remove nodes (k=2)k=2 possible facets in a graph, where M ∼ 0 (for tree-like graphs) and M ∼ 1 (for complete graphs) [14]: M = (E − V + 1)/(2V − 5) (1) Finally, we report the"organic"score to assess whether a road network has been planned or not [14], computed as the proportion of dead ends (nodes with degree k = 1) and unfinished intersections (nodes with degree k = 3) to the total number of nodes: Org = (V (k = 1) + V (k = 3))/V (2) We found that the meshness scores of cities in this study vary between 0.084 for San-Juan and 0.228 for Riyadh which are consistent with the scores reported in [6] on analyzing planar graphs of twenty cities. The low scores are mainly due to the absence of squares and triangles in real-world cities. Non surprisingly, organic scores are high for almost all the cities, with a noticeable advantage for new and fast growing cities such as Accra (0.97) and Doha (0.96) as compared to old cities such as Barcelona and San-Francisco (0.89). 2.3 Service location data Foursquare is a location-based social media network that allows users to share their location with friends through what is known as check-in. Data from such check-ins contain information about the user, the venue she is reporting on, the specific location of that venue (coordinates) and a timestamp. In this work we exploit data that were collected by Yang et al. [15, 16] from April 2012 to September 2013. This rich dataset contains 33,278,683 check-ins posted by 266,909 users on 3,680,126 unique venues, that are geographically spread in 415 cities across 77 countries. For our purposes, we only pay attention to the type of service the venue belongs to according to the Foursquare category hierarchy5; and its GPS position -- disregarding any other information. We have deliberately promoted the "Medical Centers" sub-category into a parent cat- egory to be able to assess how such a critical service is affected by failures in the city. At the end we ob- tained a list of 10 different categories of different criti- cality, including: Medical Center, Travel & Transport, Food, College & University, Residence, Arts & Enter- tainment, Shops & service, Nightlife Spot, Professional & Other Places, and Outdoors & Recreation. To integrate the network structure with services loca- tions, we assign each location to its closest node. This is tantamount to mapping service locations to their near- est intersection, allowing an efficient computation of the amount of reachable services (see Section 3). Services that are farther than 2 km for all intersections in a city are omitted from the study. 3. METHODS 5https://developer.foursquare.com/categorytree Table 1: Statistics about road networks of dif- ferent cities. Network percolation theory has already been exploited in the urban context for other purposes than the ones in this work [2, 10, 14]. With the road networks for dozens of cities at hand, we can now proceed with the percola- tion dynamics in two different ways. Both of them share the idea of progressive structural deterioration [1, 5, 7], understood either as error or failure (removal of ran- domly chosen edges); or attack (removal of important edges, where "importance" can be quantified by some descriptor, such as high betweenness of edges, high cen- trality of nodes, etc.) Note that in this work we focus on bond percolation (edges are removed) as opposed to site percolation (nodes are removed). Here we apply both Error and Attack procedures on the available networks. For the Error process, at each Sheet3Page 1CityVELength (KM)KMeshOrglos-angeles525246678652113504.4372.5840.1460.924paris36924450332054713.6412.7260.1820.915london34308145185537954.9202.6340.1590.900dallas31314739864980613.8032.5460.1370.950chicago30047940336670911.4452.6850.1710.938melbourne28567138285548425.7052.6800.1700.936new-york28079737854260445.9772.6960.1740.925denver-boulder22444129623244696.1322.6400.1600.920bangkok20506225138764109.4172.4520.1130.966rotterdam19778528038124081.9162.8350.2090.867mexico-city18456824615436659.3462.6670.1670.944milan17774624289422686.8292.7330.1830.911pittsburgh16972321141942600.9672.4910.1230.950saint-louis16705820337644989.0022.4350.1090.953rio-de-janeiro14538319322228436.1012.6580.1650.943lisbon13674018480324091.5632.7030.1760.944athens13633818865525389.0232.7670.1920.907sydney13158117463922508.0132.6540.1640.948montreal12437317204339126.4932.7670.1920.908rome11125914779417878.1762.6570.1640.920riyadh10744515644824023.6212.9120.2280.980santiago10702714660417690.6812.7400.1850.946san-francisco9949113445117644.9812.7030.1760.898glasgow9323511887711350.2642.5500.1380.953bengaluru8803711474814457.0362.6070.1520.959porto-alegre7914810828223416.5112.7360.1840.918new-orleans764389439522442.6632.4700.1170.948chennai722779272011950.4112.5660.1410.958singapore653338703913641.5702.6640.1660.931dubai644629284912127.1502.8810.2200.907san-juan61883722479027.8722.3350.0840.963barcelona591658417810104.7792.8460.2110.899amman571237677510675.9222.6880.1720.954el-paso443266016711000.2842.7150.1790.949quito430515630110406.4832.6160.1540.944durban42171533458424.4252.5300.1330.942boston40375555735656.7122.7530.1880.899dakar38640541644208.7762.8040.2010.949abudhabi38401557248006.5972.9020.2260.880doha34743485447106.8402.7940.1990.968juarez33663463137401.8112.7520.1880.949belgrade32936417805840.1792.5370.1340.937wellington27135326517811.6262.4070.1020.967manama26781371433891.0662.7740.1930.957medellin24410333975049.3792.7360.1840.902christchurch20368262205667.0412.5750.1440.939cali20001289303549.2792.8930.2230.923accra19838260794070.7702.6290.1570.974phnom-penh17283222964075.5262.5800.1450.959mandalay719095841706.1922.6660.1670.944da-nang687297771565.8532.8450.2120.930kigali662290062511.1722.7200.1800.945surat263935691040.6962.7050.1770.958 step an edge chosen uniformly at random is removed, until the size of the GCC (giant connected component) is equal to the size of the SLCC (second larger con- nected component). Connected components (and their sizes) are checked periodically (each time 1% of edges have been deleted). Because of the stochastic nature of this process, it is repeated 50 times so as to report the average expected deterioration of the network. In the Attack modality, the edge with highest between- ness centrality is removed at each step. As before, the process continues until the size of the GCC is equal to the size of the SLCC. Following these progressive schemes, as the fraction p of removed edges increases the size of the GCC (cap- tured in number of nodes) decreases, until the network undergoes a second-order phase transition at the criti- cal point pc (percolation threshold). Such transition can be spotted precisely -- it occurs when the size of SLCC becomes maximal [3]. For each network, at pc we compute the proportion of available services (gathered under ten general cate- gories) in the remaining GCC as a proxy of the capacity of a city to deliver those services in an Error/Attack scenario. 4. RESULTS We first take a look at the cities' response to Error. Figure 5 shows some examples of how random edge re- moval affects the size of the GCC. Typically, the size of the GCC is relatively stable, which indicates that the road structure is not suffering a large damage regarding overall reachability. At a given point (pc), a transition takes place (often quite abruptly, e.g. Dakar or Abu- Dhabi), after which the network is shattered into many disconnected components. Note that Error results are only reported for a subset of cities to ease the compar- ison across different experiments. Along this process, pc can be seen as an indicator of the robustness of the system to failure. A low criti- cal threshold can be interpreted as a limited capacity of the road infrastructure to support and recover from ran- dom disruption -- accidents or congestion happening at any location, or system-wide disturbance. In Figure 7 (left), cities are sorted according to their pc against ran- dom error (averaged over 50 realizations). We see there that there is a remarkably wide range of cities, with the weakest road network corresponding to Wellington (pc = 0.17), and the more robust ones to Mandalay, Cali and Boston (pc = 0.35). Such variability suggests deep structural differences beyond the obvious features reported in Table 1 (compare for instance the two men- tioned cities). We also see that most North American have made it to the top cities in terms of robustness to random error. Figure 6 shows as well the progressive deterioration of the GCC as a function of the fraction of removed edges, but in this case links are targeted with respect to their betweenness centrality. The differences with respect to Figure 5 are obvious -- transitions take place much earlier and in a much more abrupt manner. In this case, the values of pc are below 10% for any city under study, evidencing the large dependence (and, in turn, exposure and vulnerability) of the road network on a few central segments. Figure 7 (right) shows cities sorted by their percolation threshold under the targeted Attack scheme. Interestingly, we see that the ranking of cities has drastically changed in Attack. In fact, cities from Ocea- nia such as Wellington and Christchurch are turned to be among the most robust cities in these scheme while they were at the bottom of the ranking in the Error scheme. We also observe that North American cities are no longer grouped toward the head of the ranking as they were in the Error case. This suggest that cities, regardless of their location, behave differently the two failure schemes considered in our study. We further computed the overall Pearson correlation between the vectors of pc scores and we found it as low at 0.23, indi- cating that there is a very low correlation between the percolation thresholds observed in Error and Attack schemes. In other words, a city with a high robustness to Error can be very vulnerable for Attack and vice versa. The third focus of our work is related to the question of service distribution. The effects of the failure of a part of the road network are not important per se, but in terms of the possibility to reach -- or not -- any other part of the city (and the services it delivers). Thus, be- sides questioning how robust the infrastructure is (i.e. how early it breaks), we wonder now about the con- sequences of surpassing pc in terms of health, food or residential resources. Figure 8(b) summarizes the situa- tion for the 27 cities for which we could find Foursquare data. In panel (a) of the same figure, we compute for each city the average proportion of available services (across the ten categories) reachable by the GCC ob- served at percolation threshold (pc.) Here again, we found that North and South American cities such as New Orleans, New York, Motreal, Quito, and Porto- Alegre are in the top of the ranking. In the city of New Orleans for instance, only 23% of the services became unaccessible (availability around 77%.) The bottom of the ranking is fairly dominated by European cities with Rotterdam and London in the bottom 3 cities. Indeed, a city like Rotterdam could preserve access to only 26% of all its services. Also, there seem to be a negative cor- relation between the percolation threshold of a city and the fraction of services it retains. That is, the higher the percolation threshold the lower the available services. In panel (b) of Figure 8 we report the the availabil- ity of service per city per category. We represent in red the cities that lost more than 50% of services in at least on category whereas we use green to report cities that preserve at least 50% of their services in all categories. We also plot in black the average avail- Figure 5: Random failure behavior. Evolution of the size of the GCC (y-axis) as a function of the percentage of removed edges (x-axis). Results are reported for 50 randomizations. Notably, cities react differently to edge failure due to their different pc -- see Figure 7 (left). Figure 6: Intentional attack behavior: Evolution of the size of the GCC as a function of the percentage of removed edges. Again, cities react differently to edge failure -- see Figure 7 (right). 0510152025300.00.20.40.60.81.0new-orleans0510152025300.00.20.40.60.81.0phnom-penh0510152025300.00.20.40.60.81.0mandalay0510152025300.00.20.40.60.81.0cali0510152025300.00.20.40.60.81.0bengaluru0510152025300.00.20.40.60.81.0chennai0510152025300.00.20.40.60.81.0dubai0510152025300.00.20.40.60.81.0medellin0510152025300.00.20.40.60.81.0accra0510152025300.00.20.40.60.81.0surat0510152025300.00.20.40.60.81.0belgrade0510152025300.00.20.40.60.81.0riyadh0510152025300.00.20.40.60.81.0boston0510152025300.00.20.40.60.81.0da-nang0510152025300.00.20.40.60.81.0barcelona0510152025300.00.20.40.60.81.0el-paso0510152025300.00.20.40.60.81.0manama0510152025300.00.20.40.60.81.0san-juan0510152025300.00.20.40.60.81.0amman0510152025300.00.20.40.60.81.0dakar0510152025300.00.20.40.60.81.0porto-alegre0510152025300.00.20.40.60.81.0glasgow0510152025300.00.20.40.60.81.0quito0510152025300.00.20.40.60.81.0durban0510152025300.00.20.40.60.81.0singapore0510152025300.00.20.40.60.81.0abudhabi0510152025300.00.20.40.60.81.0juarez0510152025300.00.20.40.60.81.0doha0510152025300.00.20.40.60.81.0kigali0510152025300.00.20.40.60.81.0wellington0510152025300.00.20.40.60.81.0san-francisco0510152025300.00.20.40.60.81.0rome0510152025300.00.20.40.60.81.0christchurchGiant CCSecond larger CC (a) Random failure (b) Targeted attack Figure 7: Percolation point pc of different cities. The percolation point is computed as fraction of removed edges from the network when the size of the second larger connected component maximizes. Figure (a) reports the results for the random failure in which percolation thresholds are between 17% (Wellington) and 35% (Boston, Cali, and Mandalay). Figure (b) reports the results for the targeted attack. As expected, the percolation happens now much earlier, after removing only 1% of edges in New Orleans, or 2% in Phnom-Penh and Mandalay), to 9% in San Francisco, Rome and Christchurch. ability across cities for each category. As one would expect, cities are showing different patterns regarding different categories. However, a close analysis reveals that on average category availabilities are somewhat equilibrated around 55% with the following breakdown: Nightlife Spot (60.96%), Food (58.19%), Professional & Other Places (55.18%), Shop & Service (54.89%), Med- ical Center(54.76%), Arts & Entertainment (53.50%), Residence (49.51%), Outdoors & Recreation (49.36%), College & University (49.19%), Travel & Transport (49.00%). This reveals that the most affected category of services across cities is Travel and Transport that in- cludes places such as bus and metro stations, airports, rail stations, etc. In the third and last panel (c) we report examples of cities with completely different reac- tions to failures in terms of service providing. London (UK) as a city that severely suffers the failure by los- ing access to almost 70% of its services with a particu- lar emphasis on medical centers and transport; Amman (Jordan) as a mid affected city losing access to 55% of its services; and New York (US) -- as a good example -- looses only 30% of its services with a high preservation of its medical centers. 5. DISCUSSION AND PERSPECTIVES In this work, we have focused on various aspects of road network robustness. To do so, we have exploited large, publicly available datasets, and the rich tradi- tion in percolation theory. Our results indicate that phase transitions occur at different levels of deteriora- tion (early vs. late), but also in qualitatively different manners (abrupt vs. smooth). While these differences may result from different design principles [14], we sug- gest that these heterogeneous "percolation profiles" can be interpreted as a fingerprint of the city, in the sense that these profiles are unique to each of them -- while at the same time incomplete (a city is much more than its road structure). We complement the structural degradation approach with a reachability perspective, coupling the infrastruc- tural level with the services it connects. Indeed, a frac- tured road network is not critical per se, but in relation to the broken flow of people and resources. The results show again heterogeneous profiles regarding service al- location. These insights may be helpful in assessing strategies for a more balanced distribution of such ser- vices that guarantee reachability a balanced coverage even in a stressed infrastructure. Despite the simplifications that our method entails, a systematic study of these "robustness fingerprints" may lead to a classification of cities with regard to their fragility and service distribution imbalances -- along the lines of Louf & Barthelemy [11], but taking a urban re- silience angle. Beyond its academic interest, such clas- sification could lead to the design of common preventive strategies for cities whose structural features resemble each other (at least from a percolation and service allo- cation perspective). Furthermore, it could be enriched with other critical urban networks (e.g. water supply or power grid) expanding the scope of the study to multi- layer percolation [4, 8]. All of the previous falls under an overarching vision, which is related to the existing gaps between policy ac- tors and scientific activity: the pipeline between both extremes is often too narrow -- if not inexistent. There seems to be a general agreement that resilience is a de- sirable feature in urban settlements -- as the world pop- ulation increasingly flows into cities -- , but the concept becomes fuzzy when it comes to the definition of objec- tives and strategies. In an attempt to alleviate this, we wellingtonnew-orleansaccraphnom-penhquitobelgradechristchurchglasgowsan-juanabudhabidurbansingaporeammanchennaimanamaporto-alegredakardohakigalidubaisan-franciscoda-nangmedellinriyadhsuratbarcelonabengalururomeel-pasojuarezbostoncalimandalay0510152025303540EuropeOceaniaCentral AmericaAfricaAsiaNorth AmericaSouth Americanew-orleansphnom-penhmandalaycalibengaluruchennaidubaimedellinaccrasuratbelgraderiyadhbostonda-nangbarcelonael-pasomanamasan-juanammandakarporto-alegreglasgowquitodurbansingaporeabudhabijuarezdohakigaliwellingtonsan-franciscoromechristchurch0246810EuropeOceaniaCentral AmericaAfricaAsiaNorth AmericaSouth America (a) (b) (c) Figure 8: Service availability in the giant connected component at percolation threshold pc. Panel (a) reports the proportion of available services in different cities sorted from the most affected to the less affected. Panel (b): in green, cities that keep at least 50% of their services in the GCC for all categories. In red, cities that lose more than 50% services for at least one category. Panel (C): focus on three different cities with three different behaviors: London in red, Amman in yellow and New York in green have taken a specific angle of resilience (that of 100RC) and mapped some of their targets onto quantifiable, concrete measurements. There is a large body of work waiting ahead before we can come up with an objective set of methods to measure urban resilience, taking into account the wide range of temporal and spatial scales a city encloses. Acknowledgments We would like to thank Heather Leson for her discus- sions and comments that greatly improved the manuscript. 6. REFERENCES [1] R. Albert, H. Jeong, and A.-L. Barab´asi. Error and attack tolerance of complex networks. nature, 406(6794):378 -- 382, 2000. [2] E. Arcaute, C. Molinero, E. Hatna, R. Murcio, C. Vargas-Ruiz, P. Masucci, J. Wang, and M. Batty. Hierarchical organisation of britain through percolation theory. arXiv preprint arXiv:1504.08318, 2015. [3] B. Bollob´as. Random graphs. 1985. Academic, London, 1985. [4] S. V. Buldyrev, R. Parshani, G. Paul, H. E. Stanley, and S. Havlin. Catastrophic cascade of failures in interdependent networks. Nature, 464(7291):1025 -- 1028, 2010. [5] D. S. Callaway, M. E. Newman, S. H. Strogatz, and D. J. Watts. Network robustness and fragility: Percolation on random graphs. Physical review letters, 85(25):5468, 2000. [6] A. Cardillo, S. Scellato, V. Latora, and S. Porta. Structural properties of planar graphs of urban street patterns. Phys. Rev. E, 73:066107, Jun 2006. [7] R. Cohen, K. Erez, D. ben Avraham, and S. Havlin. Resilience of the internet to random breakdowns. Physical Review Letters, 85(21), 2000. [8] J. Gao, S. V. Buldyrev, H. E. Stanley, and S. Havlin. Networks formed from interdependent networks. Nature physics, 8(1):40 -- 48, 2012. [9] B. Jiang and C. Claramunt. Topological analysis of urban street networks. Environment and Planning B: Planning and Design, 31(1):151 -- 162, 2004. [10] D. Li, B. Fu, Y. Wang, G. Lu, Y. Berezin, H. E. Stanley, and S. Havlin. Percolation transition in dynamical traffic network with evolving critical bottlenecks. Proceedings of the National Academy of Sciences, 112(3):669 -- 672, 2015. [11] R. Louf and M. Barthelemy. A typology of street patterns. Journal of The Royal Society Interface, 11(101):20140924, 2014. [12] S. Meerow, J. P. Newell, and M. Stults. Defining urban resilience: A review. Landscape and Urban Planning, 147:38 -- 49, 2016. [13] S. Porta, P. Crucitti, and V. Latora. The network analysis of urban streets: A dual approach. Physica A: Statistical Mechanics and its Applications, 369(2):853 -- 866, 2006. [14] J. Wang. Resilience of self-organised and top-down planned cities. a case study on london and beijing street networks. PLoS ONE, 10(12):1 -- 20, 12 2015. [15] D. Yang, D. Zhang, L. Chen, and B. Qu. Nationtelescope: Monitoring and visualizing large-scale collective behavior in lbsns. Journal of Network and Computer Applications, 55:170 -- 180, 2015. [16] D. Yang, D. Zhang, and B. Qu. Participatory rotterdamel-pasolondonbostonbangkokathensglasgowchennailos-angeleslisboncalimilanmedellinpittsburghdallasparisammanchicagobarcelonamelbourneaccraquitoporto-alegremontrealmexico-citynew-yorknew-orleans01020304050607080Percentage of available servicesEuropeOceaniaCentral AmericaAfricaAsiaNorth AmericaSouth AmericaMedical CenterCollege & UniversityFoodResidenceTravel & TransportShop & ServiceArts & EntertainmentNightlife SpotOutdoors & RecreationProfessional & Other Places102030405060708090min(services)>= 50%min(services)< 50%avg all citiesMedical CenterCollege & UniversityFoodResidenceTravel & TransportShop & ServiceArts & EntertainmentNightlife SpotOutdoors & RecreationProfessional & Other Places1020304050607080londonammannew-york cultural mapping based on collective behavior data in location-based social networks. ACM Transactions on Intelligent Systems and Technology (TIST), 7(3):30, 2016.
1810.10034
2
1810
2019-06-02T09:37:00
Uncovering Complex Overlapping Pattern of Communities in Large-scale Social Networks
[ "cs.SI", "physics.soc-ph" ]
The conventional notion of community that favors a high ratio of internal edges to outbound edges becomes invalid when each vertex participates in multiple communities. Such a behavior is commonplace in social networks. The significant overlaps among communities make most existing community detection algorithms ineffective. The lack of effective and efficient tools resulted in very few empirical studies on large-scale detection and analyses of overlapping community structure in real social networks. We developed recently a scalable and accurate method called the Partial Community Merger Algorithm (PCMA) with linear complexity and demonstrated its effectiveness by analyzing two online social networks, Sina Weibo and Friendster, with 79.4 and 65.6 million vertices, respectively. Here, we report in-depth analyses of the 2.9 million communities detected by PCMA to uncover their complex overlapping structure. Each community usually overlaps with a significant number of other communities and has far more outbound edges than internal edges. Yet, the communities remain well separated from each other. Most vertices in a community are multi-membership vertices, and they can be at the core or the peripheral. Almost half of the entire network can be accounted for by an extremely dense network of communities, with the communities being the vertices and the overlaps being the edges. The empirical findings ask for rethinking the notion of community, especially the boundary of a community. Realizing that it is how the edges are organized that matters, the f-core is suggested as a suitable concept for overlapping community in social networks. The results shed new light on the understanding of overlapping community.
cs.SI
cs
Xu and Hui RESEARCH Uncovering Complex Overlapping Pattern of Communities in Large-scale Social Networks Elvis H. W. Xu and Pak Ming Hui Correspondence: [email protected] Department of Physics, The Chinese University of Hong Kong, Shatin, Hong Kong, China 9 1 0 2 n u J 2 ] I S . s c [ 2 v 4 3 0 0 1 . 0 1 8 1 : v i X r a Abstract The conventional notion of community that favors a high ratio of internal edges to outbound edges becomes invalid when each vertex participates in multiple communities. Such a behavior is commonplace in social networks. The significant overlaps among communities make most existing community detection algorithms ineffective. The lack of effective and efficient tools resulted in very few empirical studies on large-scale detection and analyses of overlapping community structure in real social networks. We developed recently a scalable and accurate method called the Partial Community Merger Algorithm (PCMA) with linear complexity and demonstrated its effectiveness by analyzing two online social networks, Sina Weibo and Friendster, with 79.4 and 65.6 million vertices, respectively. Here, we report in-depth analyses of the 2.9 million communities detected by PCMA to uncover their complex overlapping structure. Each community usually overlaps with a significant number of other communities and has far more outbound edges than internal edges. Yet, the communities remain well separated from each other. Most vertices in a community are multi-membership vertices, and they can be at the core or the peripheral. Almost half of the entire network can be accounted for by an extremely dense network of communities, with the communities being the vertices and the overlaps being the edges. The empirical findings ask for rethinking the notion of community, especially the boundary of a community. Realizing that it is how the edges are organized that matters, the f -core is suggested as a suitable concept for overlapping community in social networks. The results shed new light on the understanding of overlapping community. Keywords: Community structure; Overlapping community; Social network Introduction A community in networks is conceived commonly as a group of vertices connected closely with each other but only loosely to the rest of the network. Such communities are widespread in many systems and their detection has attracted much attention in the past two decades (Fortunato, 2010). This vague notion of communities is subjected to many possible interpretations. The most common one is based on the ratio of the numbers of internal edges to outbound edges, which go out of the community. The more the internal edges to outbound edges, the more definite is the community. For example, the widely used methods based on strong/weak community (Radicchi et al, 2004), LS-set (Luccio and Sami, 1969), conductivity and network community profile (Jeub et al, 2015; Leskovec et al, 2009), and fitness functions (Baumes et al, 2005; Goldberg et al, 2010; Lancichinetti et al, 2009) favor a higher internal edges to outbound edges ratio. The idea works well for disjoint communities, but it has also been adopted by algorithms for detecting overlapping Xu and Hui Page 2 of 17 communities (Xie et al, 2013). Nonetheless, the number of members, mostly at the periphery, belonging to multiple communities is still expected to be small so that an "overlapping community" remains well separated from its surrounding. However, the structure of overlapping communities in real social networks may be far more complex. It is commonplace that every individual has multiple social circles. It implies that all parts of a social community, peripheral and core, may be overlapping with a significant number of other communities and there can be far more outbound edges than internal edges. The existence of these significantly overlapped communities, as will be shown in the present work, asks for a deeper understanding of what an overlapping community really is, where their boundaries are, and how to detect them. Analyzing big data sets of real social networks is vital in network science. An immediate problem is that most existing methods are incapable of detecting signifi- cantly overlapped groups of vertices, because these groups have too many outbound edges to be identified as well separated communities. The recently proposed methods of OSLOM (Lancichinetti et al, 2011) and BIGCLAM (Yang and Leskovec, 2013) are useful to some extent in small synthetic networks, but they become inefficient for large-scale networks which readily have the size of millions to billions of vertices. Sampling small subnetworks (Maiya and Berger-Wolf, 2010) would not work either due to the small-world effect (Watts and Strogatz, 1998), e.g. the average distance between any two individuals on Facebook is only 4.74 (Backstrom et al, 2011; Ugan- der et al, 2011), while in a social group for which the size is small compared to the whole network, a member may usually need one or two hops to be connected to all the other members. A community may be considered as localized, but it is also widespread in the network. Sampling small subnetworks would preserve particu- lar communities but decompose many others, making it inappropriate for studying the overlaps among communities. Some newly proposed algorithms (Epasto et al, 2017; Lyu et al, 2016; Sun et al, 2017) achieved linear-time complexity, but their validity and accuracy in detecting significantly overlapped communities requires further benchmarking and cross-checking. The lack of effective and efficient algo- rithms resulted in very few studies on detecting and analyzing overlapping commu- nity structure in large-scale social networks. An empirical study was carried out on Facebook (Ferrara, 2012), but only methods for detecting disjoint communities were used. A recent study on Friendster found that about 30% of the vertices belonged to multiple communities (Epasto et al, 2017). Jebabli et al analyzed community structure in a sampled YouTube network of 1.1 million vertices and evaluated a number of overlapping community detection algorithms (Jebabli et al, 2015, 2018). Yang and Leskovec analyzed metadata groups of some real networks and found that overlaps occur more often at the cores of communities (Yang and Leskovec, 2014, 2015). This is contrary to the traditional notion that overlapping members are mostly at the periphery. Recent studies also revealed that metadata groups may not give the ground-truth of structural communities (Hric et al, 2014; Peel et al, 2017). The present authors developed recently a scalable partial community merger al- gorithm (PCMA) which adopts f -core as the notion of community that a member of a community should know at least a fraction f of the other members (Xu, 2016; Xu and Hui Page 3 of 17 Table 1 Information on the two huge social networks analyzed (cid:104)k(cid:105) 26.4 55.1 Dataset Sina Weibo Friendster M represents a million. n and m are the number of vertices and edges. (cid:104)k(cid:105) is the average vertex degree. CWS is the average local clustering coefficient. c is the number of communities detected by PCMA. More detailed information is given in the appendix. CWS 0.155 0.205 c 1.3M 1.6M m 1046M 1806M n 79.4M 65.6M Xu and Hui, 2018). The concept of f -core imposes no constraints or implications on the fraction of overlapping vertices in a community or the number of communities a vertex may belong to. The method is a bottom-up approach by properly reassem- bling partial information of communities found in ego networks of the vertices to reconstruct the complete communities. It consists of three steps: 1 Find communities in the ego network of each of the vertices. These communi- ties are referred to as partial communities as each of them is only part of the corresponding complete community. 2 Merge partial communities that are parts of the same community to recon- struct complete communities. 3 Clean up the noise accumulated in the merged communities to sift out the real communities. This approach is intuitive and easy to conceive. There are a number of similar algorithms such as DEMON (Coscia et al, 2012) and EgoClustering (Rees and Gallagher, 2013). The reason that PCMA achieves a far better accuracy is a novel similarity measure of communities that suppresses the amount of noise accumulated during the merging process. The present authors tested PCMA against the LFR benchmark (Lancichinetti et al, 2008) and a new benchmark designed for signifi- cantly overlapping communities, and established the accuracy and effectiveness of PCMA in detecting communities with significant overlaps, as well as slightly over- lapping and disjoint ones. The linear complexity of PCMA enabled the analysis of two huge online social networks with 79.4 and 65.6 million vertices - Sina Weibo and Friendster (see Table 1) - without sampling small subnetworks. The ∼ 2.9 mil- lion communities detected by PCMA were verified to be non-duplicating and have relatively high values of internal edge density. A surprising finding is that more than 99% of them have more outbound edges than internal edges, and the out- bound edges often outnumber the internal edges by many times. The communities overlap significantly, while still keeping relatively clear boundaries. These commu- nities are strong empirical evidence against the traditional notion of an overlapping community. While we focused on developing the PCMA algorithm in Ref. (Xu and Hui, 2018), we uncover the complex overlapping pattern of these communities in the present work by examining the data in detail and explain why the communities can still remain well separated from each other. After introducing the four main characteristics of the overlapping pattern, we give a macroscopic picture of the so- cial network structure by grouping edges of the entire network into five types. The concept and possible better definitions of an overlapping community are discussed. Additional information on the data sets and the detection of communities is given in the appendix. Xu and Hui Page 4 of 17 Characteristics of overlapping pattern In this section, we discuss in detail the four main characteristics of the overlapping pattern of the 2.9 million communities detected by PCMA. Figure 1 Belongingness distribution of vertices with different number of memberships in Sina Weibo network. The bin width of the x-axis is 0.02. A vertex with m memberships has m independent values of belongingness b, each for a community that the vertex belongs to. The distributions are almost the same, i.e. uncorrelated to m, for different values of m, with m = 1 shifted slightly to the left. The noisy peaks are due to the fact that belongingness b as defined in Eq. (1) is discrete, especially when nC is small. The Friendster network (not shown) shows the same pattern. Characteristic 1. Multi-membership vertices or overlapping vertices account for the majority of the community, and they are everywhere. These vertices were often thought to be peripheral members. A recent study on metadata groups (Yang and Leskovec, 2014) found that these vertices are more likely core members. Our analysis on the two large-scale social networks reveals that the overlapping vertices can be anywhere, i.e., core and periphery, in the community. In general, a vertex v may belong to mv communities. The vertices can then be sorted by their values of mv = m for m (cid:62) 1. The belongingness bv,C of a vertex v to a community C can be defined as bv,C = kint v,C nC − 1 (1) where nC is the community size and kint v,C is the number of other members in C that are connected to v. A high (low) value of bv,C means that v is closer to the core (periphery) of C. If overlaps occur more often at the periphery (core), we would expect multi-membership vertices with m > 1 to have a lower (higher) belonging- ness b than those with m = 1. Fig. 1 shows that the belongingness distributions for vertices with different values of m are almost identical, with an insignificant tendency of multi-membership vertices having a slightly higher belongingness. The 0.00.20.40.60.81.0Vertexbelongingnessb0.000.010.020.030.040.050.060.070.08Distributionm=1m=2m=3m=4m=5m=6m=7m=8m=9m>1 Xu and Hui Page 5 of 17 results imply that mv is basically uncorrelated with bv,C, and multi-membership vertices exist everywhere in a community with no preference towards the core or the periphery as compared with non-overlapping vertices. Figure 2 Membership distribution pm of vertices with m (cid:62) 1 and the empirical probability Pm that a member of a community has m memberships. Pm is right skewed because a vertex with m memberships is counted m times (since it appears in m communities) compared to pm. Fig. 2 shows the distribution pm of the number of memberships among the vertices with m (cid:62) 1. About 50% of the vertices, i.e., those with m > 1, have multiple memberships in Sina Weibo. For Friendster, the proportion is ∼ 60%, which is about twice of that reported in Ref. (Epasto et al, 2017). A related quantity is Pm = , (2) pm · m (cid:104)m(cid:105) which gives the empirical probability that a member of a community has m mem- berships. Here, (cid:104)m(cid:105) = (cid:80)∞m=1 pm · m is the mean value of m. Note that Pm and pm are related but different. Pm is the expected membership distribution of the members within a community, and pm describes the distribution in m of all vertices with m (cid:62) 1. Referring to Pm in Fig. 2, Pm=1 = 18.8% and 12.9% for Sina Weibo and Friendster, respectively, implying that on average more than 80% of the mem- bers in a community are multi-membership vertices. This is in sharp contrast to the preconceived idea that only a small fraction of members in a community belong also to other communities. The results reveal that most members of a community have multiple memberships and they are everywhere in the community. Characteristic 2. The multi-membership vertices lead to a community over- lapping with many other communities. We refer to them as neighbor communities. Fig. 3 shows the relationship between the number of neighbor communities dC and the size nC of a community in the two social networks. To extract information, the 12345678910Numberofmembershipsm0.00.10.20.30.40.5Distributionpm(SinaWeibo)pm(Friendster)Pm(SinaWeibo)Pm(Friendster) Xu and Hui Page 6 of 17 Figure 3 The relationship between a community's size and the number of its neighbor communities. Data are shown for community sizes from 6 to 100. The values in each vertical cut of the histograms are rescaled by mapping the highest value to unity. The bottom figure shows the averaged values and their standard deviations. 020406080100CommunitysizenC0100200300400500NumofneighborcommunitiesdCSinaWeibo020406080100CommunitysizenC0100200300400500Friendster020406080100CommunitysizenC0100200300400500Avgnumofneighborcommunities¯dCSinaWeiboFriendster0.00.10.20.30.40.50.60.70.80.91.0 Xu and Hui Page 7 of 17 expected number of neighbor communities for a community of size nC is roughly ¯dC (nC) ≈ ((cid:104)m(cid:105)C − 1) · nC · rnd where (cid:104)m(cid:105)C = ∞(cid:88) m=1 Pm · m = (cid:10)m2(cid:11) (cid:104)m(cid:105) (3) (4) is the expected number of memberships of a member in the community. Although each member connects the community to (cid:104)m(cid:105)C − 1 other communities of which it is also a member, ((cid:104)m(cid:105)C − 1) · nC overestimates the number of neighbor com- munities due to duplication, i.e., some members in the community have common neighbor communities. A factor rnd is introduced to represent the non-duplicate rate. Consider the simple case of a size-nC community with x members all in only one neighbor community. In this case, ((cid:104)m(cid:105)C − 1) · nC = x while ¯dC = 1, implying rnd = 1/x. Thus, the value of rnd also indicates the extent of overlap between two communities. For overlaps of just 2 or 3 vertices, rnd drops below 50%. The anal- ysis in Fig. 3 confirms that ¯dC ∼ nC, but with a slope gradually decreasing with increasing nC. Thus, rnd is negatively correlated with nC. The slopes are around 3 ∼ 4, which are about 30% smaller than the values 4.36 and 5.25 calculated by ((cid:104)m(cid:105)C−1) from empirical data of Sina Weibo and Friendster, respectively. Note that these slopes are very large, e.g. a community of size as small as 30 could overlap with ∼ 100 other communities concurrently. The resulting non-duplicate rates rnd are above 70%, strongly indicating that most overlaps concern just one vertex. (cid:88) kint C = (cid:88) Characteristic 3. In contrast to the generally believed notion that a community should have more internal edges than outbound edges, we found that more than 99% of the 2.9 million communities have more outbound edges than internal edges. For each community identified by PCMA, we evaluated the total number of internal edges kint C and outbound edges kout C : kint v,C, kout C = kout v,C (5) v∈C v∈C v,C (kout where kint v,C) denotes the number of a vertex v's edges that go inside (outside) the community C. The summations are over all nC vertices in the community. Note that each internal edge is counted twice as both ends are within the community and each outbound edge is included only once. Figure 4 shows that the number of outbound edges of a community is not only greater, but often many times greater than the number of internal edges. More than 99% of the 2.9 million communities have more outbound edges than internal edges, in contrast to the traditional notion. To investigate into the network structure, we focused on the outbound edges and classified them into 3 categories (see Fig. 5) as E1: outbound edges from a member to a neighbor community to which the member also belongs; E2: outbound edges from a member to a neighbor community that the member does not belong to; Xu and Hui Page 8 of 17 Figure 4 Histogram of communities grouped by the average internal and outbound edges per member. The numbers of bins in the x and y axes are 200 and 400, respectively. The counting in each bin is normalized by dividing the count by the total number of communities and the bin area. The bin area of the right panel is two times the left panel. To make the normalized values comparable to those in Figure 6, we set the bin area of the left panel to 1. The normalized counting in each bin is given by the color, as defined by the color bar. More than 99% of the detected communities have kout is usually much greater than kint C . C C > kint C , and kout Figure 5 Edges can be classified into five types: (1) intra-community edges; (2) inter-community edges between two overlapped communities; (3) inter-community edges between two communities that do not overlap; (4) edges between vertices with membership m > 0 and isolated vertices (m = 0); (5) edges between isolated vertices. Focusing on the outbound edges of the green community with 5 members (circled), the edges 1b, 2, and 3+4 correspond to categories E1, E2, and E3 outbound edges of the green community, respectively, as defined in the text. Different from the five types which classify edges of the whole network, the three categories E1, E2, and E3 are used to classify the outbound edges of a community and thus are introduced from the viewpoint of a particular community. There are some overlaps between the two types of classification: (1) An E1 outbound edge is by definition a Type 1 edge; (2) A Type 2 (Type 3) edge is also an E2 (E3) outbound edge of the two corresponding communities that the edge connects. However, the reverse relationship is not always true. These types and categories are not interchangeable. 01020304050kintC/nC050100150200250koutC/nCSinaWeibo01020304050kintC/nC0100200300400500Friendster10−610−510−41a1b2345 Xu and Hui Page 9 of 17 Figure 6 Histogram of communities grouped by the proportions of E1 and E2 outbound edges. The numbers of bins in the x and y axes are 400 and 200, respectively. The counting in each bin is normalized by dividing the number by the total number of communities in each panel. E3: outbound edges not to a neighbor community. Their proportions e1, e2, e3, with e1 + e2 + e3 = 1, are calculated for each com- munity. Fig. 6 shows the histograms. Typically, the edges to a neighbor community are usually through the common member(s) of the two communities as e1 is much greater than e2. In addition, a significant proportion of outbound edges go to neigh- bor communities. In Sina Weibo, most communities (red region) have e1 + e2 ≈ 0.5. It means that ∼ 50% outbound edges are due to the vertices' multi-membership and communities are densely connected to their neighbor communities. Note that if a community's outbound edges were randomly connected to vertices in the network, most edges would be of category E3. Characteristic 4. How can communities ever be distinguished when each com- munity overlaps with a significant number of others? The answer is that the overlap size between two communities is usually small, and the connection between them is mostly through the overlap. Table 2 lists the frequency of occurrence of the most common overlap sizes. Out of 232M (millions) overlaps among the 2.9M de- tected communities, more than 80% are of just a single vertex. Fig. 7 shows the actual structure of two detected communities. The outbound edges from commu- nity A (left) to its neighbor community B are highly organized through the overlap. Members of B usually only know the overlapping part of A, and vice versa. The overlapped vertex serves as the sole bridge and plays a unique role in passing in- formation between the communities. Yet, there may exist some E2 edges between the communities. In social networks, they are possibly due to the common mem- 0.00.10.20.30.40.5Friendster0.00.20.40.60.81.0ProportionofE1outboundedgese10.00.10.20.30.40.5SinaWeiboProportionofE2outboundedgese210−610−510−4 Xu and Hui Page 10 of 17 ber introducing members of the two communities to know each other. In Fig. 6, e2 is below 10% or even 5% for most communities and far less than e1. It is the small proportion of E2 edges that facilitates the easy separation of communities. The proportion e2 is thus an indicator of the clearness of the boundary between a community and its neighbor communities. We checked every pair of overlapped communities on E2 edges. Results are listed in Table 2. For 37.8% (Sina Weibo) and 30.1% (Friendster) of them, there is not even a single E2 edge. The communities maintain a good separation from their surrounding despite each overlaps with a significant number of neighbor communities. Table 2 Distribution of overlaps as a function of size of overlaps and the number of E2 edges between a pair of communities Dataset No. of overlaps Sina Weibo Friendster 77 million 155 million 1 Overlap size (no. of vertices) 4 No. of E2 edges of an overlap (cid:54) 5 0 84.5% 8.3% 2.6% 1.3% 37.8% 10.5% 6.0% 64.0% 86.1% 7.7% 2.4% 1.1% 30.1% 11.0% 6.7% 59.4% 2 3 1 2 Figure 7 A real example of a pair of overlapped communities detected by PCMA. The overlap is a single vertex colored half purple and half red. The outbound edges from the left (right) community to the right (left) are all through the overlapped vertex (category E1), except for one edge that interconnects the two communities directly (category E2). Since an E2 outbound edge of a community is also an E2 outbound edge of the corresponding neighbor community, we adopt a simplified term that the edge is an E2 edge of the overlap. Most overlaps are like those in this example, having only one vertex and very few E2 edges, making the corresponding pair of communities well separated from each other. Mesoscopic view of social network structure For the 2.9 million detected communities, we can classify all the edges in the two so- cial networks into 5 types (see the caption of Fig. 5). The results are given in Table 3. The number of Type 1 edges suggests that the communities account for 30 ∼ 35% of the entire network in terms of edges. These communities, connected together by the huge number of overlaps, form an extremely dense and tight network by themselves. There are 10 ∼ 20% of the edges further connecting the overlapped communities (Type 2). The total number of them is comparable to that of Type 1, but since they are distributed among the huge number of overlaps, each overlap shares only a very Xu and Hui Page 11 of 17 Table 3 Classification of edges and vertices in social networks. M represents a million. The types of edges are defined as in Fig. 5. Dataset Vertices (m > 0) Vertices (m = 0) Edge Type 1 Edge Type 2 Edge Type 3 Edge Type 4 Edge Type 5 Sina Weibo Friendster 21.0M 26.5% 28.0M 42.7% 58.3M 73.5% 37.6M 57.3% 363M 34.7% 531M 29.4% 333M 18.4% 117M 11.2% 644M 35.7% 204M 19.5% 271M 15.0% 273M 26.1% 8.7% 1.5% 91M 28M few such edges. For example, in Sina Weibo, the 117M Type 2 edges are distributed among 73M overlaps, on average only 1.6 per overlap. The numbers further confirm the structure shown in Fig. 7. The Types 1 and 2 edges, together occupying half of the entire network, form an immense network of communities that can be regarded as a hidden skeleton of the social network in the mesoscopic scale. The remaining half of the edges are outside the skeleton, mostly Type 3 or Type 4. The former are "long-range" weak ties connecting different parts of the skeleton, thus making the skeleton an even smaller world. Although the majority of the vertices are outside the skeleton, i.e., vertices with m = 0, the edges among them (Type 5) account for less than 10%. For Friendster it is only 1.5%. These vertices are possibly the inactive users in the two online social network services. The edge classification helps decompose the entire network and reveals a remark- ably high proportion of the significantly overlapped communities. The proportion could be even higher if less tightly connected vertices are also accepted as commu- nities. The immense size of the network of communities confirms its important role in social networks and invites in-depth analyses on the properties of the huge and dense skeleton of social networks. Rethinking the concept of overlapping community The strong empirical evidence from the analyses of the two social networks contra- dicts what we usually think a community is and asks for a reconsideration of the concept of community. Despite a wide variety of definitions, most of them, if not all, share an intuitive idea: members of a community should have some sort of internal cohesion and good separation from the rest of the network. The problem is how the idea should be interpreted, especially what a good separation and the boundary of a community are about. (or kout C C C C + kout C C /kint (cid:1)α (cid:1) and network community profile (Jeub et al, 2015; C > kout C + kout C /(cid:0)kint C /(cid:0)kint Many definitions and quality measures of a community interpret "good separa- C ), the more definite is the community. Ex- (Radicchi et al, 2004), (Goldberg et al, 2010; Lancichinetti et al, 2009), tion" as the less the kout amples include the widely used weak community kint fitness function kint conductance kout Leskovec et al, 2009), dynamic-based definitions such as random walk (Rosvall and Bergstrom, 2008) and label propagation (Raghavan et al, 2007). We argue that comparing kout C is ineffective in large-scale networks, no matter for overlapping or disjoint communities. As shown in Figs. 4 and 6, there are more outbound edges than internal edges, even if we ignore the neighbor community edges produced by the multi-membership vertices. The point is that simply a larger value of kout C does not necessarily mean the community is less definite. Consider the case that an ar- bitrary large number of outbound edges of a community are randomly distributed C /kint Xu and Hui Page 12 of 17 in the whole network, the community is not really strongly connected to any part of the network as long as the network size n (cid:29) kout C . This point has also been discussed in a recent review by Fortunato and Hric (2016). They suggested using edge probabilities instead of the number of edges. A member of a community should have a higher probability pin to form edges with the other members than pout with vertices outside the community. Recent studies on detectability transitions in the Stochastic Block Model (Decelle et al, 2011; Nadakuditi and Newman, 2012; Radic- chi, 2013, 2014, 2018) found that pin > pout is insufficient to guarantee that the community is detectable. There exists a region 0 < pin − pout < ∆ that, although the community structure exists, no algorithms are able to detect. It is generally difficult to infer the edge probability between each pair of vertices. A simplified way is to assume the edge probabilities within a community (to the outside) are the C / [nC(nC − 1)], same and equal to the internal (outbound) edge density δint C / [nC(n − nC)],) where n and nC are the network and community sizes, (δout C = kout C → 0, making the respectively. However for large networks n (cid:29) nC, usually δout definition δint C = kint C not useful. C > δout (and so of δout C C The problem of kout C , but where the kout C ) is that it counts the outbound edges to the whole network and reports only a summed quantity. What really matters is not the number kout outbound edges are distributed. As discussed under Characteristic 4 of the overlapping pattern, a multi-membership vertex may contribute much to kout C without messing up the boundary between the community and its neighbors. On the contrary, adding a number of outbound edges to a par- ticular vertex outside is sufficient to change the boundary of the community. These two cases are due to the different distribution patterns of outbound edges: • Outbound edges from the same member to vertices outside the community • Outbound edges from different members to a particular vertex outside the community For the first case, it does not matter how many outbound edges there are. For the second case, however, the fewer the better. A good definition of overlapping community should be able to distinguish between the two cases. A useful concept here, as discussed in Ref. (Xu and Hui, 2018), is the f -core -- a maximal connected subgraph in which each vertex is connected to equal to or more than a fraction f of the other vertices in the subgraph: (cid:62) f, bv,C ∀v ∈ C (6) with bv,C being the belongingness of v to C as defined in Eq. (1). A vertex is acknowl- edged as a member of an f -core as long as the vertex has sufficient connections to the other members of the f -core. It is irrelevant whether it is connected to a large number of vertices outside the f -core. This property of f -core distinguishes the two cases of outbound edges successfully and allows a vertex to belong to multiple f -cores naturally. In contrast, the number-based counterpart called k-core, which requires each vertex to be a neighbor to at least k other vertices in the subgraph, is non-overlapping by definition. The "maximal connected subgraph" in the definition ensures all vertices outside the f -core having belongingness less than f , as defined in Eq. (6), except for the case that there does exist one vertex outside, but including Xu and Hui Page 13 of 17 it will result in some other member(s) of the f -core to be kicked out. The fraction f defines the boundary of the community. A problem is that there is no standard way to determine what value of f should be used. Communities in social networks often show core-periphery structures (Csermely et al, 2013; Rombach et al, 2014; Zhang et al, 2015) and have no definite boundaries. A large value of f extracts the core members of communities, and a small value results in more peripheral vertices being accepted as members. We are of the opinion that the belongingness bv,C is a better way to describe vertex memberships instead of forcing a vertex to be either inside or outside of a community. While the f -core is a good candidate, better definitions of overlapping community may still be possible. The key point is that the definition should take into account of the possibility of ubiquitous presence of multi-membership vertices: • The proportion of multi-membership vertices may range from 0 ∼ 100%, • A vertex may belong to an arbitrary number of communities, as revealed by data analysis. These are the causes of the significant overlaps among communities and a much greater number of outbound edges than internal edges. Summary and outlook We studied the overlapping structure of 2.9 million communities detected by PCMA in the two huge online social networks. We found four main characteristics: • Most members of a community have multiple memberships. They are every- where, at the periphery or in the core. • A community usually overlaps with a significant number of other communities, the number typically is several times its size. • The number of outbound edges of a community is many times greater than the number of internal edges. • Although communities overlap significantly, they remain relatively in good separation from each other. Most overlaps concern just one or sometimes two vertices. Note that PCMA does not impose any constraint or implications on the fraction of overlapping vertices in a community or the number of communities a vertex may have. It is also capable of detecting non-overlapping or slightly overlapping communities, as verified in the LFR benchmarking test (Lancichinetti et al, 2008) in Ref. (Xu and Hui, 2018). The significant overlapping pattern found in the two empirical social networks asks for a rethinking of what the boundary of a community really is. We discussed several traditional interpretations and related issues, and suggested the f -core as a possible definition for overlapping community. Our study also showed a dense and tight network of communities, with the communities taking the role of vertices and the overlaps being the edges. Most overlaps are just of a single vertex. Each of these vertices plays a unique role in passing on information between the communities that it belongs to. This network of communities accounts for almost half of the entire network. It serves more studies on how its structural properties would couple to many phenomena in social dynamics. As implied by the no-free lunch theorem for community detection that there can be no algorithm which is optimal for all possible community detection tasks (Peel et al, 2017), methods based on different approaches may reveal different aspects of Xu and Hui Page 14 of 17 the community structure. In fact, there is no standard answer to what a community really is, and it is largely unnecessary to enforce only one definition. This is espe- cially the case for empirical networks. The important thing is that the communities detected satisfy the general notion of a community that they have internal cohesion and relatively clear boundaries. We verified that the 2.9 million communities ana- lyzed in the present work have good separation among each other, and high values of the intra-community edge density, as shown in the Appendix. In conclusion, our empirical study unfolded new aspects of overlapping commu- nity. The results provided researchers with clues for designing effective detection algorithms, generative models, and benchmarks for overlapping communities, espe- cially in social networks. We look forward to more empirical studies powered by new tools, to cross-check the present work and explore areas not covered by PCMA. Appendix: Datasets For completeness, we describe the two social networks we analyzed. Table 1 gives the basic information. Sina Weibo is a directed network akin to Twitter. We fo- cused on the embedded friendship network in which two connected individuals are following each other. Instead of sampling small subnetworks, we collected almost the whole giant component of the network, because the structural completeness of the sampled network is vital to the preservation of community structure, especially the overlapping pattern among communities. The network data of Friendster was downloaded from SNAP Datasets (Leskovec and Krevl, 2014). We detected about 1.3 and 1.6 million communities in the two networks with PCMA (Xu and Hui, 2018). The algorithm is especially suitable for detecting com- munities in which the vertices have multiple memberships. Detailed information on the detection was reported in Ref. (Xu and Hui, 2018). Specifically, the three steps of PCMA were discussed in Section 2 and the choice of the parameters for detecting the communities within PCMA were discussed in Appendix B of the paper. Using the symbols introduced in Subsection 2.2 in Ref. (Xu and Hui, 2018), we used a harsh threshold l (cid:62) 10 to ensure that the detected communities are reliable (the larger the l, the more reliable the community). A drawback is that many small size communities were not included. In the present work, we add additional communities of which 6 (cid:54) l (cid:54) 9 and g > 3.0/l. The results are shown in Fig. 8. The latter con- dition ensures relatively high intra-community edge density of these communities, especially for those with low l. Figure 9 shows that all communities, including the newly added ones, have high values of intra-community edge density. The large values of the proportion of intra-community and E2 edges, as shown in Table 3, indicate that the number of communities we detected is close to the possible total number of communities in the two networks. However, it should be noted that there is no standard answer as to how many communities there are in a real network. We found that adding or removing the additional communities in the analyses only produces minor changes to the statistics. In particular, it does not change the characteristics of the overlapping pattern we discussed. The 2.9 million detected communities are believed to be adequate and representative. Abbreviations PCMA: Partial community merger algorithm Xu and Hui Page 15 of 17 Figure 8 Size distributions of the communities detected in the two social networks. Figure 9 Histograms of the detected communities grouped by their size and intra-community edge density. The value, as given by the color, in each vertical cut are rescaled by mapping the highest value to unity. 020406080100120Communitysize0500010000150002000025000300003500040000NumberofcommunitiesSinaWeibo(+additional)Friendster(+additional)SinaWeiboFriendster0102030405060Communitysize0.00.20.40.60.81.0Intra-communityedgedensitySinaWeibo0102030405060CommunitysizeFriendster0.00.10.20.30.40.50.60.70.80.91.0 Xu and Hui Page 16 of 17 Acknowledgements One of us (EHWX) gratefully acknowledges the support from the Research Grants Council of Hong Kong SAR Government through a Hong Kong PhD Fellowship. Authors' contributions EHWX designed the research and performed the analyses. EHWX and PMH wrote the manuscript. Both authors read and approved the final manuscript. Availability of data and materials The network data of Friendster is available in the SNAP Datasets repository, http://snap.stanford.edu/data. The network data of Sina Weibo was collected from weibo.com. Due to the current terms and conditions of the platform, the authors cannot distribute the collected data. The source code of PCMA is available at https://github.com/hwxu/pcma. Funding The authors declare that no funding was received for the research reported. Competing interests The authors declare that they have no competing interests. References Backstrom L, Boldi P, Rosa M, Ugander J, Vigna S (2011) Four Degrees of Separation. arXiv 1111.4570v3 Baumes J, Goldberg M, Krishnamoorthy M, Magdon-Ismail M, Preston N (2005) Finding communities by clustering a graph into overlapping subgraphs. In: Proceedings of the IADIS International Conference on Applied Computing, pp 97 -- 104 Coscia M, Rossetti G, Giannotti F, Pedreschi D (2012) DEMON: a Local-First Discovery Method for Overlapping Communities. In: Proceedings of the 18th ACM SIGKDD International Conference on Knowledge Discovery and Data Mining, ACM Press, New York, New York, USA, pp 615 -- 623, Csermely P, London A, Wu LY, Uzzi B (2013) Structure and dynamics of core/periphery networks. J Complex Netw 1(2):93 -- 123, Decelle A, Krzakala F, Moore C, Zdeborov´a L (2011) Inference and Phase Transitions in the Detection of Modules in Sparse Networks. Physical Review Letters 107(6):065,701, Epasto A, Lattanzi S, Paes Leme R (2017) Ego-Splitting Framework: from Non-Overlapping to Overlapping Clusters. In: Proceedings of the 23rd ACM SIGKDD International Conference on Knowledge Discovery and Data Mining, ACM, New York, NY, USA, KDD '17, pp 145 -- 154, Ferrara E (2012) A large-scale community structure analysis in Facebook. EPJ Data Sci 1(1):9, Fortunato S (2010) Community detection in graphs. Phys Rep 486(3-5):75 -- 174, Fortunato S, Hric D (2016) Community detection in networks: A user guide. Phys Rep 659:1 -- 44, Goldberg M, Kelley S, Magdon-Ismail M, Mertsalov K, Wallace A (2010) Finding Overlapping Communities in Social Networks. In: 2010 IEEE Second International Conference on Social Computing (SocialCom), IEEE, pp 104 -- 113, Hric D, Darst RK, Fortunato S (2014) Community detection in networks: Structural communities versus ground truth. Phys Rev E 90(6):062,805, Jebabli M, Cherifi H, Cherifi C, Hamouda A (2015) User and group networks on YouTube: A comparative analysis. In: 2015 IEEE/ACS 12th International Conference of Computer Systems and Applications (AICCSA), IEEE, pp 1 -- 8, Jebabli M, Cherifi H, Cherifi C, Hamouda A (2018) Community detection algorithm evaluation with ground-truth data. Physica A 492:651 -- 706, Jeub LGS, Balachandran P, Porter MA, Mucha PJ, Mahoney MW (2015) Think locally, act locally: Detection of small, medium-sized, and large communities in large networks. Phys Rev E 91(1):012,821, Lancichinetti A, Fortunato S, Radicchi F (2008) Benchmark graphs for testing community detection algorithms. Phys Rev E 78(4):046,110, Lancichinetti A, Fortunato S, Kert´esz J (2009) Detecting the overlapping and hierarchical community structure in complex networks. New J Phys 11(3):033,015, Lancichinetti A, Radicchi F, Ramasco JJ, Fortunato S (2011) Finding Statistically Significant Communities in Networks. PLoS ONE 6(4):e18,961, Leskovec J, Krevl A (2014) SNAP Datasets: Stanford large network dataset collection. http://snap.stanford.edu/data Leskovec J, Lang KJ, Dasgupta A, Mahoney MW (2009) Community Structure in Large Networks: Natural Cluster Sizes and the Absence of Large Well-Defined Clusters. Internet Math 6(1):29 -- 123, Luccio F, Sami M (1969) On the Decomposition of Networks in Minimally Interconnected Subnetworks. IEEE Trans Circuit Theory 16(2):184 -- 188, Lyu T, Bing L, Zhang Z, Zhang Y (2016) Efficient and Scalable Detection of Overlapping Communities in Big Networks. In: 2016 IEEE 16th International Conference on Data Mining (ICDM), IEEE, pp 1071 -- 1076, Maiya AS, Berger-Wolf TY (2010) Sampling community structure. In: Proceedings of the 19th International Conference on World Wide Web, ACM, New York, NY, USA, WWW '10, pp 701 -- 710, Nadakuditi RR, Newman MEJ (2012) Graph Spectra and the Detectability of Community Structure in Networks. Physical Review Letters 108(18):188,701, Peel L, Larremore DB, Clauset A (2017) The ground truth about metadata and community detection in networks. Sci Adv 3(5):e1602,548, Radicchi F (2013) Detectability of communities in heterogeneous networks. Physical Review E 88(1):010,801, Radicchi F (2014) A paradox in community detection. Europhysics Letters 106(3):38,001, Radicchi F (2018) Decoding communities in networks. Physical Review E 97(2):022,316, Xu and Hui Page 17 of 17 Radicchi F, Castellano C, Cecconi F, Loreto V, Parisi D (2004) Defining and identifying communities in networks. Proc Natl Acad Sci USA 101(9):2658 -- 2663, Raghavan UN, Albert R, Kumara S (2007) Near linear time algorithm to detect community structures in large-scale networks. Phys Rev E 76(3):036,106, Rees BS, Gallagher KB (2013) EgoClustering: Overlapping Community Detection via Merged Friendship-Groups. In: The Influence of Technology on Social Network Analysis and Mining, Springer Vienna, Vienna, pp 1 -- 20, Rombach MP, Porter MA, Fowler JH, Mucha PJ (2014) Core-Periphery Structure in Networks. SIAM J Appl Math 74(1):167 -- 190, Rosvall M, Bergstrom CT (2008) Maps of random walks on complex networks reveal community structure. Proc Natl Acad Sci USA 105(4):1118 -- 1123, Sun H, Jie W, Sauer C, Ma S, Han G, Wang Z, Xing K (2017) A Parallel Self-Organizing Community Detection Algorithm Based on Swarm Intelligence for Large Scale Complex Networks. In: 2017 IEEE 41st Annual Computer Software and Applications Conference (COMPSAC), IEEE, pp 806 -- 815, Ugander J, Karrer B, Backstrom L, Marlow C (2011) The Anatomy of the Facebook Social Graph. arXiv 1111.4503v1 Watts DJ, Strogatz SH (1998) Collective dynamics of 'small-world' networks. Nature 393(6684):440 -- 442, Xie J, Kelley S, Szymanski BK (2013) Overlapping community detection in networks: The state-of-the-art and comparative study. ACM Comput Surv 45(4):43:1 -- 43:35, Xu EHW (2016) Partial Community Merger Algorithm. https://github.com/hwxu/pcma Xu EHW, Hui PM (2018) Efficient detection of communities with significant overlaps in networks: Partial community merger algorithm. Netw Sci 6(1):71 -- 96, Yang J, Leskovec J (2013) Overlapping Community Detection at Scale: A Nonnegative Matrix Factorization Approach. In: Proceedings of the 6th ACM International Conference on Web Search and Data Mining, ACM, New York, NY, USA, WSDM '13, pp 587 -- 596, Yang J, Leskovec J (2014) Structure and Overlaps of Ground-Truth Communities in Networks. ACM Trans Intell Syst Technol 5(2):26:1 -- 26:35, Yang J, Leskovec J (2015) Defining and evaluating network communities based on ground-truth. Knowl Inf Syst 42(1):181 -- 213, Zhang X, Martin T, Newman MEJ (2015) Identification of core-periphery structure in networks. Phys Rev E 91(3):032,803,
1509.07178
1
1509
2015-09-23T23:11:46
America Tweets China: A Fine-Grained Analysis of the State and Individual Characteristics Regarding Attitudes towards China
[ "cs.SI" ]
The U.S.-China relationship is arguably the most important bilateral relationship in the 21st century. Typically it is measured through opinion polls, for example, by Gallup and Pew Institute. In this paper, we propose a new method to measure U.S.-China relations using data from Twitter, one of the most popular social networks. Compared with traditional opinion polls, our method has two distinctive advantages. First, our sample size is significantly larger. National opinion polls have at most a few thousand samples. Our data set has 724,146 samples. The large size of our data set enables us to perform state level analysis, which so far even large opinion polls have left unexplored. Second, our method can control for fixed state and date effects. We first demonstrate the existence of inter-state and inter-day variances and then control for these variances in our regression analysis. Empirically, our study is able to replicate the stylized results from opinion polls as well as generate new insights. At the state level, we find New York, Michigan, Indiana and Arizona are the top four most China-friendly states. Wyoming, South Dakota, Kansas and Nevada are most homogeneous. At the individual level, we find attitudes towards China improve as an individual's Twitter experience grows longer and more intense. We also find individuals of Chinese ethnicity are statistically more China-friendly.
cs.SI
cs
America Tweets China: A Fine-Grained Analysis of the State and Individual Characteristics Regarding Attitudes towards China Yu Wang Department of Political Science University of Rochester Rochester, NY, 14627, USA [email protected] Jianbo Yuan Department of Computer Science University of Rochester Rochester, NY, 14627, USA [email protected] Jiebo Luo Department of Computer Science University of Rochester Rochester, NY, 14627, USA [email protected] 5 1 0 2 p e S 3 2 ] I S . s c [ 1 v 8 7 1 7 0 . 9 0 5 1 : v i X r a Abstract -- The U.S.-China relationship is arguably the most important bilateral relationship in the 21st century. Typically it is measured through opinion polls, for example, by Gallup and Pew Institute. In this paper, we propose a new method to measure U.S.-China relations using data from Twitter, one of the most popular social networks. Compared with traditional opinion polls, our method has two distinctive advantages. First, our sample size is significantly larger. National opinion polls have at most a few thousand samples. Our data set has 724,146 samples. The large size of our data set enables us to perform state level analysis, which so far even large opinion polls have left unexplored. Second, our method can control for fixed state and date effects. We first demonstrate the existence of inter-state and inter-day variances and then control for these variances in our regression analysis. Empirically, our study is able to replicate the stylized results from opinion polls as well as generate new insights. At the state level, we find New York, Michigan, Indiana and Arizona are the top four most China- friendly states. Wyoming, South Dakota, Kansas and Nevada are most homogeneous. At the individual level, we find attitudes towards China improve as an individual's Twitter experience grows longer and more intense. We also find individuals of Chinese ethnicity are statistically more China-friendly. Keywords- U.S.-China relations; Perceptions; Tweets; Senti- ment Analysis; I. INTRODUCTION In international relations, perceptions matter [1], [2]. And how the U.S. perceives China matters particularly, the former being the world's only superpower and the latter a potential challenger. Typically these perceptions are measured using opinion polls. For example, a February 2015 survey by Foreign Policy shows that the majority of American students who studied in China have developed a more positive view of the country (sample size: 343) [3]. A February 2014 poll survey by Gallup shows that 53% of Americans view China very or mostly unfavorably (sample size: 1,023) [4]. While opinion polls have been the standard way for gauging public opinion, their weaknesses are obvious. First and foremost, the small sample size, as evidenced above, renders any fine grained analysis extremely difficult if not impossible [5]. Second, these opinion polls, mostly carried out on an annual basis, are susceptible to the influence of daily events. Surveys before or after the event can yield drastically different results, and yet both will be used as representing the annual result. In this paper, we propose a method that can solve these two problems. We measure U.S. perceptions of China through Twitter. With 302 million active monthly users, Twitter is one of the most popular social networks in the world.1 In the U.S. alone there are 69.46 million users. The huge amount of data generated by U.S. users is an ideal repository for mining U.S. perceptions of China. It enables us to achieve what have so far evaded opinion polls. Specifically, with a large data set, we are able to carry out state level analysis as never before. By utilizing the time-stamps contained in tweets, we are able to control for fixed time effects. Utilizing the location information, we are able to control for fixed state effects. Figure 1: America Tweets China, aggregated at the provin- cial level. This map is generated with 25,677 China-focused tweets. Data does not include Hong Kong SAR, Macao SAR or Taiwan. Empirically, our study successfully replicates the stylized findings from conventional opinion polls as well as generate 1https://about.twitter.com/company. new insights. We find that New York, Michigan, Indiana and Arizona are the top four China-friendly U.S. states and that Wyoming, Wisconsin, South Dakota and West Virginia are the least friendly. Wyoming, South Dakota, Kansas and Nevada are the most homogeneous in attitudes towards China. Michigan, New Hampshire, New Jersey and Wis- consin are the least homogeneous. At the individual level, we find attitudes towards China improve as the individuals' Twitter experience grows longer and more intense. We also find that individuals of Chinese ethnicity are statistically more China-friendly. Our paper proceeds as follows. Section 2 presents related literature on international relations, sentiment analysis using Twitter data, and inferring geo-information in the tweets. Section 3 presents our data and data processing procedures. Section 4 presents our state-level analysis. Section 5 presents the individual level analysis. Section 6 concludes. II. LITERATURE REVIEW Our study builds on previous research both in international relations and in computer science. China's rise is quickly reshaping the post-Cold War inter- national structure [6]. Lake argues that if China continues to grow, it is likely to bid for its own subordinates to counter America's current hierarchies [7]. Mearsheimer, a proponent of offensive realism, contends that China's rise will not be peaceful and that China will "try to dominate Asia the way the United States dominates the Western Hemisphere" [8]. Perceptions matter in international relations [1], [2] and particularly so in the relations between the U.S. and China. Johnson, through analyzing Chinese publications, argues that the common description in U.S. media, pundit, and academia of an increasingly assertive China is ill-founded and points out the dangers of misperception [9]. Accurate perceptions are likely to contribute to trust while misguided perceptions could well lead to conflict and even war. We believe tweets can be used to measure U.S. percep- tions. The abundance of data generated through Twitter has attracted researchers from various fields. Bollen et al. use Twitter mood to predict the stock market [10]; Paul and Drezde mine tweets for public health topics [11]; and An et al. use Twitter data to track opinions about climate change [12]. Among this group of researchers there are also political scientists. For example, Tumasjan et al. use the tweets to predict election results [13]. Barberá analyzes the network structure of Twitter users to infer political ideology [14]. In order to perform state level analysis, our study makes extensive use of the geo-information in the tweets. In this ef- fort, we benefit from the research by Hecht et al. [15]. Their work identifies various problems with geo-information. We adhere to their suggestions and select only those tweets that have a case-sensitive state address such as CA in "Los Angeles, CA", New York in "Upper Manhattan, New York" and Vermont in "Vermont, USA." For the purpose of this study, we stop at the state level and do not go to the city level. III. DATA AND PROCESSING In this section, we first describe our data set and the processing procedures. Second, we define tweet level, state level and user level features respectively. Third, we use time- series tweets and pseudo-labeled tweets to test the validity of the sentiment analysis tool TextBlob. A. Data We compile a corpus of tweets using the Twitter search API between 10th and 29th of March, and between May 16th and June 15th. We perform a query-based search (China OR Chinese) to collect English tweets related to China. We then select those tweets with a state address. When a tweet can be attributed to multiple U.S. states, we attribute that tweet to all the identified states. Details of the processing procedure are described below. In the end, after removing duplicates, we have each associated id, a state id, and a time stamp.2 with a unique tweet collected 724,146 tweets, Input: tweeti Output: tweeti's attributes, or null If tweeti does not contain stop words For each statej ∈ {51 U.S. states}3. If statej in tweeti.place assign tweeti to statej extract all the attributes evaluate polarity of tweeti For each provincek ∈ {31 Chinese provinces} If provincek in tweeti.text assign tweeti to provincek For each namel ∈ {100 common Chinese names} If namel in tweeti.username Chinese=1 Else Chinese=0 End if End for End if From China's Xinhua News Agency's website, we obtain the top 100 most common Chinese surnames, which are used by 84.77% of the Chinese population.4 We use these names to identify Twitter users of Chinese ethnicity. When translated into pinyin, these 100 names result in 85 distinct names. We report these names in alphabetic order in Table 1. 2The data sets and the codes are available at the authors' website: https://sites.google.com/site/wangyurochester/. 3For the purpose of this study, we treat Washington, D.C. as a state. 4http://news.xinhuanet.com/society/2007-04/24/content_6021482.htm. Table I: Most Common Chinese Surnames C. External Validity Bai Cheng Dong Feng Guo Hu Kong Lin Lv Pan Ren Sun Wan Xiang Xue Yin Zheng Cao Cai Dai Cui Duan Du Gao Fu Hao Han Jia Huang Li Lei Long Liu Mao Ma Qian Peng Shi Shao Tan Tang Wang Wei Xie Xiao Yang Yan Yuan Yu Zhong Zhou Chen Ceng Ding Deng Fang Fan Gu Gong Hou He Jin Jiang Liao Liang Lu Luo Meng Mo Qiu Qin Song Su Tian Tao Xia Wu Xu Xiong Ye Yao Zhao Zhang Zhu Zou Out of the 101,907 individuals in the sample data set, we are able to identify 938 individuals with Chinese surnames, which represents 0.923% of the sample. This is close to the official figure 1.02%, published by the Census Bureau in 2010.5 B. Features We validate the viability of using Textblob to measure sentiments towards China.6 So far as we know, there have been no state-level (cross-sectional) opinion polls on U.S.- China relations. All the data measuring U.S. attitudes to- wards China are limited to the national level. Indeed, this is one of the motivations for this study. We decide to use time series data for the purpose of validation, as significant events between the two countries are easily recognizable and unanimity is easy to achieve. Three events stood out between May and June: the South China Sea crisis starting on May 20th, the Yangtze River accident on June 1st and Hong Kong protests on June 14th. As shown in Fig. 2 below, these events are well reflected in the aggregate national sentiments. Thus, Textblob passes our time-series test. (cid:80) fs,i Tweet features: Polarity: This is defined as how positive the tweet is, ranging from -1 to 1. Polarity is calculated using Textblob. With polarity, we can view each China-focused tweet as a vote. Other tweet features include followers, followees, retweets, and reply (binary). State level features: Friendliness: This is defined as the arithmetic average of the tweets' polarity scores for each state, ranging from -1 to 1. Fs = . It measures the state's aggregate sentiment towards China. Variance: This is defined as the variance of the tweets' polarity scores for each state. Vs = V ar(fs,i). Variance measures how varied each state's attitudes are towards China. We call a state homogeneous if the variance is small. Individual level features: Experience: This is defined as the length of the period the individual has been using Twitter. It is calculated as date1- date0, where date1 is the day when the tweet is posted and date0 is the day when the Twitter account is created. Intensity: This is defined as the average number of tweets the individual posts per day. It is calculated as date1−date0+1 . Chinese: This is defined as whether the individual has a Chinese surname. It is binary. n #tweets Figure 2: U.S. sentiment towards China, May 14-June 15. We further test Textblob's performance with tweets that contain emoticons. Davidov et al. have shown that smileys, as well as hashtags, in tweets can be used as labels [16]. We first choose two specific smileys: ":)" for positve and ":(" for negative. We are able to find 1255 tweets with these emoticons in our sample. The testing rule is as follows: Correct: if Textblob returns polarity>=0 for ":)" or if Textblob returns polarity<=0 for ":(" This is a lenient test as tweets that contain emoticons and are marked as neutral are automatically classified as correct. The testing results, reported below, are satisfactory. Sample Size Accuracy (%) Sensitivity (%) Specificity (%) 1255 92.4 95.6 72.3 5http://www.census.gov/prod/cen2010/briefs/c2010br-11.pdf. 6http://textblob.readthedocs.org/en/dev. IV. STATE LEVEL ANALYSIS In this section, we investigate the state characteristics of the tweets. We first calculate the volume of tweets that can be attributed to each state and compare our statistics with Google Trend. We then create a State-Province Matrix that projects tweets generated in a U.S. state to a Chinese province. The dimension of our matrix is 51 (states) x 31 (provinces). Third, we evaluate the friendliness and variance of each state based on our data set. A. Volume of Tweets by State Following the processing procedure described in Section 3, we obtain 724,146 China-focused tweets geocoded to the state level. We then calculate the total number of tweets assigned to each state. The summary statistics are reported below. first log-transform our counts of tweets. The Google index is used as it is. We plot the Google index as the x axis and plot our Twitter index as the y axis. The result is reported in Fig. 4. The Twitter index and the Google index are highly correlated, with a correlation coefficient of 0.76 (sample size: 51). One pattern stands out here. The top three states New York, California and Washington, DC score very high by both measures. The bottom four states South Dakota, Montana, Wyoming and New Mexico score very low by both measures. The remaining forty-four states lie in between. Table II: Summary statistics per state Max. 149043 Std. Dev. Min. 1836 Variable Mean tweets 14199 23085 N 51 In terms of the total number of tweets, the top four states are New York, California, Washington, D.C., and Texas. When controlling for state population, Washington, D.C. generates by far the most China-focused tweets per capita. The bottom four states are Vermont, New Mexico, West Virginia and South Dakota. Detailed geographical comparisons are reported in Fig. 3. Figure 3: America tweets China, aggregated at state level. This map is generated with 724,146 China-focused tweets. Washington, D.C. is not shown on the map. For cross validation, we compare our results with the state-based index generated from the Google Trend.7 The Google index measures the frequency with which people in each U.S. state search for the keyword China between Jan. 4, 2004 and Jun. 21, 2015. To make for easy comparison, we Figure 4: Compare Twitter with Google. β represents the linear regression coefficient. Standard error of the estimation is reported in parentheses. B. The State-Province Matrix The large size of our data set enables us to achieve state level analysis that has so far evaded most researchers. Moreover, by examining the contents of these tweets more closely, we are able to identify which Chinese province a tweet is targeted at. Connecting the state of origin to the province of destination, we can build a State-Province matrix of dimension 51 × 31. The matrix, built with 25,677 tweets, is reported in Table 3. Each row represents a U.S. state and each column a Chinese province. Values in each row represent the distribution of tweets in the 31 Chinese provinces. Their sum has been normalized to 1. Two immediate observations follow. First, nationwide most of the tweets can be attributed to three Chinese provinces: Beijing, Shanghai and Tibet. Xinjiang province makes a distant fourth. Second, there exists large inter-state variation. For example, the share of tweets that go to Beijing ranges from 24.3% for Delaware to 60.0% for Rhode Island. For the majority of the U.S. states (44 out of 51), the largest share of tweets goes to Beijing.8 For Delaware, Idaho, New 7https://www.google.com/trends/ 8We observe two ties and in both cases we decide to side with Beijing. Table III: State-Province Matrix Matrix Ḑ   _ ᵞ  ᪺  ˧ ᐼ  ⎎  ℳ R  ᔡ   ☘ ▷  ʘ   U A   3.1 0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0 23.1 0.0 AK 1.5 29.2 1.5 0.0 0.0 0.0 4.6 0.0 29.2 0.0 0.0 0.0 1.5 0.0 4.6 1.5 0.0 1.8 1.8 1.3 0.0 0.5 0.3 0.0 0.0 0.0 0.3 0.0 0.3 18.9 0.0 0.3 39.5 1.3 0.0 0.0 1.0 2.5 3.8 16.6 3.5 0.3 0.8 1.0 0.0 AL 2.5 1.8 0.3 0.6 1.4 1.1 0.6 0.3 0.0 0.3 0.6 0.0 0.3 0.9 0.0 22.6 0.0 AR 0.3 41.1 1.7 0.0 0.9 2.0 1.1 2.3 14.0 2.3 0.0 0.3 0.6 0.0 3.4 1.4 0.0 1.2 0.9 0.6 0.3 0.0 0.3 0.0 0.6 0.0 1.2 0.0 0.3 19.3 0.0 0.9 50.0 0.9 0.9 0.0 2.7 8.4 AZ 2.7 0.6 1.8 0.0 0.0 1.8 1.2 0.0 1.5 1.8 0.9 1.0 2.0 0.0 0.5 0.1 0.1 0.4 0.2 0.2 0.2 0.5 19.9 0.2 CA 0.3 37.0 1.0 0.2 0.2 0.8 14.6 0.4 1.6 0.6 0.1 1.7 0.9 10.3 2.7 1.3 0.3 1.3 1.3 1.9 0.0 0.4 0.2 0.2 0.6 0.0 0.4 0.0 0.2 19.3 0.0 CO 0.4 35.3 1.7 0.0 0.2 0.4 1.5 0.6 14.1 13.1 2.8 0.0 2.1 0.4 0.6 0.6 0.0 0.0 0.4 0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0 1.9 25.1 0.0 1.1 36.7 0.7 0.4 0.0 2.6 1.5 4.1 13.9 CT 0.7 0.0 1.5 4.9 0.0 3.7 0.4 0.4 0.5 0.7 0.5 0.1 1.0 0.3 0.2 1.0 0.1 0.5 0.4 0.5 15.2 0.2 DC 0.1 50.9 1.0 0.5 0.1 0.8 7.6 1.2 0.5 0.7 1.0 12.0 0.4 0.1 1.5 0.5 0.1 1.4 1.4 0.7 0.0 0.7 0.0 0.0 0.7 0.7 0.7 0.7 0.7 26.4 0.0 0.7 24.3 0.7 0.7 1.4 0.7 9.5 0.7 0.7 2.0 0.0 21.6 0.7 0.7 0.7 1.4 0.0 DE 1.3 1.0 1.4 0.1 0.1 0.1 0.0 0.2 0.1 0.2 0.1 0.3 30.7 0.2 0.1 43.3 1.1 0.3 0.1 0.3 7.6 2.5 0.0 1.8 0.3 0.2 FL 1.1 2.2 0.6 1.7 1.1 1.1 1.5 1.5 0.4 0.7 0.0 0.2 0.7 0.0 0.0 0.0 0.2 17.4 0.2 GA 0.0 52.6 0.2 2.0 0.2 0.2 0.2 0.2 12.0 2.2 0.4 0.9 0.7 0.4 2.4 1.1 0.4 0.9 0.0 0.0 0.3 0.3 0.0 0.0 0.3 0.0 0.9 0.9 0.0 14.8 0.0 0.3 58.9 0.6 0.0 0.3 0.6 0.9 0.3 11.8 HI 0.9 0.3 1.2 0.0 0.0 3.0 1.2 1.2 0.6 1.3 1.3 0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0 23.1 0.0 IA 0.0 41.9 1.3 0.0 0.0 0.0 6.3 1.9 0.6 2.5 0.0 12.5 4.4 0.0 1.3 1.3 0.0 2.1 0.7 1.4 0.0 0.7 0.0 0.0 0.0 0.0 0.7 0.0 0.0 38.0 0.7 ID 0.0 29.6 0.7 0.0 0.7 0.0 1.4 0.7 16.2 0.7 0.7 0.0 0.0 0.0 2.1 2.8 0.0 0.9 0.5 0.9 0.0 0.2 0.2 0.5 0.2 0.0 0.2 0.0 0.5 21.4 0.0 0.5 46.9 0.5 0.5 0.2 0.5 2.3 1.9 12.4 2.3 0.7 0.7 1.6 0.0 IL 1.4 0.9 0.9 1.4 0.4 1.2 0.3 0.6 0.2 0.5 0.1 0.0 0.1 0.1 0.6 22.5 0.1 IN 0.6 39.4 0.6 0.5 0.0 1.0 1.6 1.0 15.1 2.1 0.6 1.7 0.8 0.1 4.0 2.5 0.6 0.0 1.4 1.4 0.0 0.0 0.0 0.5 1.0 0.0 0.0 0.0 0.0 32.9 0.0 0.0 41.9 0.5 1.0 0.0 1.4 7.1 6.7 1.4 0.0 KS 1.4 0.0 1.0 0.0 0.0 0.0 0.5 1.2 1.2 0.0 0.0 1.2 0.0 0.6 6.0 0.0 0.0 0.0 0.0 16.3 0.0 KY 0.0 31.3 2.4 0.0 0.0 1.2 0.0 1.2 25.3 1.8 1.2 0.6 0.0 0.0 4.2 4.2 0.0 1.2 0.6 2.1 0.3 0.0 0.6 0.0 0.0 0.0 0.3 0.0 0.0 21.1 0.0 LA 0.0 29.2 0.9 0.9 0.3 0.3 2.1 0.9 32.2 0.9 0.9 2.4 0.6 0.0 0.9 1.2 0.0 9.3 1.2 0.5 0.0 0.0 0.0 0.0 1.2 0.0 0.0 0.0 0.2 27.4 0.0 MA 0.0 34.7 0.7 1.2 0.0 0.5 9.1 3.0 0.7 0.9 0.5 0.2 1.6 2.1 0.7 2.1 2.3 0.4 0.9 0.4 0.0 0.0 0.0 0.0 0.4 0.0 0.9 0.4 0.0 19.8 0.0 MD 0.4 44.1 1.3 0.0 0.0 0.0 5.7 0.9 0.4 3.1 0.9 13.7 2.6 0.0 1.8 1.8 0.0 0.0 1.0 2.1 0.0 0.5 0.5 0.0 1.0 0.0 0.0 0.0 1.0 30.9 0.0 ME 0.0 36.6 0.0 0.0 0.0 1.0 1.6 2.6 11.0 1.0 0.0 2.1 0.5 0.0 4.2 2.1 0.0 1.0 0.6 1.1 0.0 0.3 0.0 0.3 0.2 0.0 0.0 0.0 0.3 21.2 0.0 0.2 54.7 0.5 0.3 0.0 0.3 1.5 2.3 10.7 1.6 0.0 0.5 0.2 0.2 MI 0.6 1.1 0.3 0.5 0.5 0.5 0.0 0.5 0.0 0.5 0.5 0.0 0.0 0.0 0.0 25.4 0.0 MN 1.0 38.3 0.0 0.0 0.5 1.0 2.0 4.5 14.9 2.5 0.5 2.0 0.5 0.0 2.5 1.5 0.0 1.6 2.3 0.8 1.6 0.8 0.0 0.0 0.8 0.0 0.8 0.0 0.0 22.7 0.0 MO 0.0 40.6 0.0 1.6 0.0 1.6 9.4 2.3 0.0 1.6 0.8 0.0 3.1 4.7 0.0 0.8 2.3 2.5 3.3 3.3 0.0 0.0 0.0 0.0 2.5 0.0 0.0 0.0 0.0 24.6 0.0 0.0 37.7 0.8 0.0 0.0 0.0 0.8 0.0 15.6 0.8 0.0 0.0 1.6 0.0 MS 0.0 5.7 0.8 0.0 0.0 0.0 0.0 0.0 0.0 0.0 3.8 0.0 0.0 0.0 1.3 25.0 0.0 MT 0.0 37.5 1.3 1.3 0.0 0.0 6.3 0.0 2.5 3.8 0.0 1.3 0.0 13.8 1.3 1.3 0.0 0.6 1.5 1.1 0.0 0.2 0.0 0.0 0.0 0.0 0.2 0.0 0.4 28.7 0.0 2.1 0.2 9.1 0.2 0.0 NC 0.2 36.5 0.9 0.6 0.2 1.1 0.4 0.2 14.2 0.9 0.4 0.2 1.5 0.4 0.8 0.0 0.8 0.0 0.0 0.0 0.0 0.4 0.0 0.4 23.3 0.0 ND 0.0 36.3 0.4 0.0 0.0 0.8 1.1 1.5 21.4 3.4 1.1 0.8 0.8 0.4 1.9 2.3 0.4 0.0 0.9 0.9 0.4 0.9 0.0 0.0 0.9 0.0 0.4 0.0 0.4 27.2 0.0 0.0 35.7 0.9 1.8 0.0 1.3 1.8 0.9 11.6 3.1 0.9 1.8 0.4 0.0 NE 2.2 4.9 0.4 0.8 0.0 1.6 0.8 0.0 24.4 0.8 0.8 0.0 0.8 0.8 0.0 0.0 0.0 0.0 0.0 0.0 20.5 0.0 NH 0.8 31.5 0.8 1.6 0.0 0.0 7.9 2.4 0.8 0.8 1.6 0.8 1.6 54.9 1.2 0.3 0.2 0.5 0.3 0.7 0.9 0.0 0.5 0.0 0.0 0.9 0.0 0.2 0.2 0.7 17.8 0.0 8.3 NJ 1.7 0.9 2.4 0.7 0.0 1.2 0.3 1.7 1.6 0.3 1.1 0.0 2.3 0.0 1.1 0.0 0.0 0.0 0.0 0.0 0.0 0.0 21.6 1.1 15.9 6.8 13.6 NM 0.0 19.3 6.8 0.0 1.1 0.0 3.4 1.1 0.0 3.4 0.0 1.1 0.0 0.0 0.6 0.6 13.3 0.6 1.7 2.2 0.0 0.6 0.0 0.0 1.1 0.0 0.6 0.6 0.0 16.1 0.0 NV 1.1 46.1 0.6 0.6 1.1 0.6 3.3 0.6 2.2 2.2 1.1 1.7 1.1 0.0 1.0 0.6 16.2 0.7 0.5 1.2 0.1 0.3 0.1 0.1 0.2 0.0 0.1 0.2 0.2 21.8 0.1 NY 0.7 49.7 0.4 0.5 0.2 0.5 1.7 0.9 0.2 0.6 0.3 0.7 0.3 0.1 6.8 3.1 1.1 1.7 0.4 1.5 0.0 0.2 0.0 0.0 0.9 0.2 0.2 0.7 0.7 24.8 0.0 OH 0.2 37.3 0.7 0.7 0.0 0.9 7.6 4.1 1.5 2.2 0.7 1.3 0.4 0.2 OK 0.0 35.4 0.6 0.0 0.0 0.6 1.9 1.9 0.6 0.0 0.6 0.0 0.0 0.6 0.0 0.6 0.0 0.0 29.8 0.0 1.2 0.6 15.5 1.2 0.0 0.6 0.6 0.0 4.3 1.9 1.2 2.4 1.3 12.6 0.8 1.0 1.0 0.3 0.0 0.0 0.0 0.3 0.0 0.0 0.0 0.5 32.5 0.3 OR 0.3 32.5 2.4 0.8 0.3 1.8 2.1 0.3 0.8 1.3 0.0 3.1 1.6 0.0 1.5 3.0 16.9 17.9 1.2 1.0 1.0 0.5 0.3 0.0 0.0 0.0 0.3 0.5 0.0 0.0 0.2 0.3 20.0 0.0 PA 0.5 29.3 1.0 0.3 0.2 0.7 2.0 0.7 0.7 0.2 0.2 1.1 1.4 0.0 0.0 0.4 0.0 0.0 0.0 0.0 0.0 0.0 0.4 20.4 0.4 0.4 60.0 0.0 0.0 0.0 0.7 2.1 2.1 0.4 0.0 4.2 1.1 0.4 0.7 0.4 0.0 RI 3.9 0.5 0.5 10.6 1.6 1.1 0.0 0.0 0.5 0.0 0.0 0.0 0.0 0.0 0.0 0.0 23.9 0.5 SC 0.5 49.5 1.1 0.0 0.0 1.6 2.1 1.6 0.0 1.6 0.5 2.1 0.0 0.0 SD 0.0 31.3 2.1 0.0 0.0 2.1 0.0 0.0 2.1 0.0 0.0 0.0 0.0 2.1 0.0 0.0 0.0 0.0 43.8 0.0 6.3 0.0 0.0 0.0 2.1 0.0 2.1 2.1 4.2 0.0 0.0 2.4 1.9 10.6 0.5 1.0 1.4 0.0 1.0 0.0 0.0 0.0 0.0 1.0 0.0 0.0 19.2 0.0 TN 0.0 52.4 1.0 0.0 0.0 1.0 2.4 1.4 0.5 1.0 0.5 0.5 0.5 0.0 8.9 8.1 1.1 1.9 0.1 0.5 0.2 0.0 0.4 0.0 0.3 0.0 0.4 22.4 0.1 TX 0.4 42.0 0.8 0.0 0.1 1.0 1.3 1.3 0.4 1.9 1.1 3.0 0.3 0.4 1.5 0.4 7.4 0.5 2.1 1.6 0.5 0.5 1.1 0.5 1.6 0.0 0.5 0.5 1.1 23.2 0.5 1.1 39.5 2.6 0.0 0.0 0.0 1.1 2.1 2.1 2.6 1.1 2.1 1.1 1.1 2.1 0.0 UT 0.5 1.1 1.9 0.0 1.1 0.0 0.3 0.5 0.0 0.0 0.0 0.0 22.5 0.3 VA 0.5 49.0 1.6 0.5 0.3 0.3 9.3 0.5 1.1 2.7 0.3 0.5 0.5 0.0 1.9 2.5 0.0 0.0 28.6 0.0 0.0 0.0 0.0 0.0 1.3 0.0 0.0 0.0 0.0 0.0 1.3 0.0 1.3 0.0 0.0 32.5 0.0 1.3 0.0 15.6 11.7 5.2 0.0 VT 1.3 0.0 0.0 0.0 0.0 1.8 0.8 13.4 0.6 0.6 0.9 0.3 0.8 0.2 0.3 0.5 0.0 0.2 0.0 0.8 24.8 0.2 WA 0.3 42.1 1.1 0.9 0.2 0.5 1.8 2.3 0.2 0.9 0.5 2.6 0.9 0.0 2.4 1.4 2.1 0.7 0.7 0.3 0.0 0.0 0.0 0.0 0.0 0.3 22.6 1.4 1.0 41.1 1.0 2.4 0.3 1.0 8.6 3.4 2.1 0.3 2.1 1.4 2.1 0.3 1.0 0.0 0.0 WI 4.5 1.5 16.4 0.0 1.5 0.0 1.5 1.5 0.0 1.5 3.0 0.0 0.0 0.0 0.0 25.4 0.0 WV 0.0 29.9 0.0 1.5 0.0 1.5 4.5 1.5 0.0 3.0 0.0 0.0 1.5 0.0 WY 0.0 32.6 2.2 0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0 2.2 2.2 0.0 0.0 4.3 4.3 0.0 34.8 0.0 6.5 4.3 0.0 0.0 0.0 0.0 0.0 2.2 4.3 0.0 0.0 Note: (in original order) Ḑ: Anhui, :Beijing, : Chongqing, _: Fujian, ᵞ: Gansu, : Guangdong, ᪺: Guangxi, : Guizhou, ˧: Hainan, ᐼ: Hebei, : Heilongjiang, : Henan, ⎎: Hubei, : Hunan, ℳ: Inner Mongolia, R: Jiangsu, : Jiangxi, ᔡ: Jilin, : Liaoning, : Ningxia, ☘: Qinghai, ▷: Shaanxi, : Shandong, : Shanghai, ʘ: Shanxi, : Sichuan, : Tianjin, U: Tibet, A: Xinjiang, : Yunnan, : Zhejiang. Mexico, South Dakota, Vermont and Wyoming (6 out of 51), Shanghai receives the most tweets. For Louisiana, it is Tibet. C. Friendliness and Variance Opinion polls on U.S.-China relations mostly stop at the national level. By contrast, we are able to explore state level nuances. In particular, we are able to measure the friendliness of each state towards China. This is important because hardly ever have international relations been mea- sured without regard to security issues, and security concerns vary across countries. Studying state level attitudes enables us to control for security issues in a perfect way as we can assume all U.S. states share the same security concerns with regards to China. In addition to friendliness, we are also able to measure how varied perceptions of China are in each state. The results are reported in Fig. 5. We find that the top four most friendly states are New York, Michigan, Indiana and Arizona and that the least friendly four states are Wyoming, Wisconsin, South Dakota and West Virginia. In terms of variance, we find the top four most homogeneous states are Wyoming, South Dakota, Kansas and Nevada and that the least homogeneous states are Michigan, New Hampshire, New Jersey and Wisconsin. Though we do not explore it here, we point out that it will be of great significance to analyze the causal mechanisms behind these differences between states. We suggest that in- ternational trade and Chinese immigration can be influential factors. V. INDIVIDUAL LEVEL ANALYSIS In this section, we first introduce our statistical model and then report our main estimation results. Lastly, we perform two separate F tests on the state and date control variables. A. The Model Our primary goal here is to replicate some of the stylized results from opinion polls [17], [3]: • American individuals who follow news about China have less favorable views of China. • American opinion leaders are more likely to have a favorable view of China. • American students who have studied in China are more likely to have a favorable view of China. Our dependent variable is the polarity of the tweet. We use followers and intensity, introduced in Section 2, to capture the effects of opinion leaders. That is, we treat individuals with more followers and more posted tweets as opinion leaders. In the original study, the opinion leaders consist of U.S. government officials, think tank leaders, media personnel, business executives, and university faculties [17]. We use variables followees and retweet to capture the effects of following news. The variable reply controls for the effects of being in a conversation. Additionally, we examine the effects of Chinese ethnicity on attitudes towards China. The size of our data set also allows us to control for state and time fixed effects. As previous sections have shown, there is large variation across U.S. states and between different days, so we decide to control for both state and time effects. Altogether, this suggests that following statistical model: yi = β1 · f ollowersi + β2 · f olloweesi + β3 · retweeti + β4 · replyi + β5 · experiencei + β6 · intensityi + Diα + Ciλ + Siγ + i where Di = [di 1 si 17] control for date effects, Si = 50] control for state effects and Ci controls for the 2 ... di 1 di 2 ... si [si effects of Chinese ethnicity. B. The Main Results We estimate our model with OLS regression and the estimation results are reported in Table 4. Each column represents one regression and has its own specification. The first column displays estimates without controlling for state and time fixed effects. The second column presents the same coefficients but controls for state fixed effects. The third column controls for time fixed effects. The fourth column incorporates both state and time fixed effects. For the fifth column, we aggregate the tweets on an indi- vidual and daily basis by taking the average. This reduces the number of observations from 245,664 to 162,982. The six column, with 242,673 observations, reports estimates for individuals not identified as ethnically Chinese. The seventh column, with 2991 observations, reports estimates for individuals identified as ethnically Chinese. Our results (Columns 1-5) are consistent with the findings the coefficient for intensity is cited above. Specifically, positive and statistically significant, indicating that opinion leaders, in our case individuals who tweet more often, are more likely to have a positive view of China. The coefficient for followers is not statistically significant. Coefficients for followees and retweet are both negative and statistically significant. This is consistent with the find- ing that individuals who follow news about China have less favorable views of the country. We also find experience to have a statistically positive effect. This suggests a positive learning experience using Twitter and supports that finding that American students who have studied in China tend to have more positive views of the country. The estimate for Chinese is positive in all the first five specifications, but is statistically significant only in Test 5, when we aggregate individuals' daily tweets. Comparing the results in the sixth column and the seventh column, we find individuals of Chinese ethnicity behave differently from the rest of the sample. For example, the co- efficient on followers is positive and statistically significant. Figure 5: Friendliness and Variance. The top figure reports the friendliness index for each state. The bottom figure reports the variance index for each state. Table IV: Estimation Results tweet polarity (4) Date effects State & Date effects (6) (7) Non-Chinese Ethnicity Chinese Ethnicity 0.000000725∗∗ -0.00000138∗∗ -1.23e-09 (-0.73) (2.73) -0.000000326∗∗∗ -0.000000898∗∗ (-7.52) (-2.91) 0.0215∗∗∗ (16.64) 0.00000290∗∗∗ 0.0000869∗∗∗ (4.82) (66.62) (-3.04) 0.00000340 (0.18) 0.0192 (1.73) -0.000000992 (-0.17) -0.000113 (-1.85) followers followees retweet reply experience intensity Chinese (1) Baseline 2.80e-11 (0.02) (2) State effects -1.33e-09 (-0.79) (3) 1.62e-10 (0.10) -0.000000353∗∗∗ -0.000000333∗∗∗ -0.000000352∗∗∗ -0.000000935∗∗ -0.000000907∗∗ -0.000000871∗∗ (-7.74) (-8.22) (-8.19) (-2.94) 0.0219∗∗∗ (17.10) 0.00000337∗∗∗ 0.0000930∗∗∗ (5.68) (78.96) 0.000187 (0.05) No No Yes (-2.83) 0.0217∗∗∗ (16.90) 0.00000293∗∗∗ 0.0000870∗∗∗ (4.91) (67.11) 0.00337 (0.83) Yes No Yes (-3.03) 0.0219∗∗∗ (17.11) 0.00000332∗∗∗ 0.0000927∗∗∗ (5.60) (78.46) 0.000348 (0.09) No Yes Yes -1.21e-09 (-0.72) -0.000000331∗∗∗ -0.000000897∗∗ (-7.70) (-2.91) 0.0217∗∗∗ (16.91) 0.00000287∗∗∗ 0.0000865∗∗∗ (4.81) (66.54) 0.00344 (0.85) Yes Yes Yes (5) Aggregated -9.00e-11 (-0.04) -0.000000154∗∗ -0.00000154∗∗∗ (-2.80) (2.46) (-4.75) 0.0219∗∗∗ (14.41) 0.00000170∗ 0.0000855∗∗∗ (40.29) 0.0210∗∗∗ (3.98) Yes Yes Yes state effects date effects constant 245664 N adj. R2 0.028 t statistics in parentheses ∗ p < 0.05, ∗∗ p < 0.01, ∗∗∗ p < 0.001 Estimates for control variables are not reported. In the following subsection, joint F tests are used to show that they are statistically different from zero. Yes Yes Yes 2991 0.042 245664 0.030 245664 0.030 245664 0.031 162982 0.016 242673 0.031 Yes Yes Yes The estimates on retweet, reply, experience and intensity are no longer statistically significant. [2] A. H. Kydd, Trust and Mistrust in International Relations. Princ, 2005. C. F tests To test the significance of the state and date effects, we perform two separate F tests based on the fourth column in Table 4. The testing results are reported below. With F(50, 245589)=6.88, we reject the null hypothesis that co- efficients on state control variables are all zeros. With F(17, 245589)=16.99, we are able to reject the null hypothesis that the coefficients on date control variables are all zeros. These tests further confirm the existence of inter-state and inter-day variations. Table V: F Tests on control variables state coefficients date coefficients F(50, 245589)=6.88 F(17, 245589)=16.99 Prob>F=0.0000 Prob>F=0.0000 VI. CONCLUSION The U.S.-China relationship is arguably the most impor- tant bilateral relationship in the 21st century. It demands detailed measurement and analysis. In this paper, we have proposed a new method to measure this relationship using tweets. With a large data set, we are able to carry out state level analysis. Utilizing geo-information and time stamps, we can control for fixed state and time effects. We demon- strate the existence of inter-state and inter-day variations and control for them in our regression analysis. Our work replicates some stylized results from opinion polls as well as generate new insights. At the state level, we find New York, Michigan, Indiana and Arizona are the top four most China-friendly states. Wyoming, South Dakota, Kansas and Nevada are most homogeneous. At the individual level, we find attitudes towards China improve as the individuals' Twitter experience grows longer and more intense. We also find individuals of Chinese ethnicity are more China-friendly. Our study is the first to analyze U.S.-China relations using Twitter data. The results we achieve are very encouraging. In future research we intend to increase the size of our data set and further refine our analytic tools. ACKNOWLEDGMENT Yu Wang would like to thank the Department of Political Science at the University of Rochester for warm encourage- ment and generous funding. This work was also generously supported in part by Google, Yahoo, Adobe, TCL, and New York State CoE CEIS and IDS. REFERENCES [1] R. Jervis, Perceptions and Misperceptions in International Politics. Prince, 1976. [3] (2015, May) risks, For no some [Online]. Available: american-students-in-china-fp-survey-no-regrets-china-u-cross-cultural-natives-college-university-education-abroad/ Foreign regrets. students american china, Policy. http://foreignpolicy.com/2015/05/27/ in [4] A. Dugan. (2014, February) Americans view china mostly unfavorably. [Online]. Available: http://www.gallup.com/ poll/167498/americans-view-china-mostly-unfavorably.aspx? version=print [5] J. R. Lax and J. H. Phillips, "How should we estimate public opinion in the states," American Joural of Political Science, vol. 53, no. 1, pp. 107 -- 121, January 2009. [6] K. N. Waltz, Theory of International Politics. McGraw-Hill Publishing Company, 1979. [7] D. A. Lake, Hierarchy in International Relations. Cornell University Press, 2009. [8] J. J. Mearsheimer, The Tragedy of Great Power Politics. W.W.Norton & Company, Inc., 2014. [9] A. I. Johnson, "How new and assertive is china's new assertiveness?" International Security, vol. 37, no. 4, pp. 7 -- 48, 2013. [10] J. Bollen, H. Mao, and X.-J. Zeng, "Twitter mood predicts the stock market," Journal of Computational Science, vol. 2, no. 1, pp. 1 -- 8, March 2011. [11] M. J. Paul and M. Dredze, "You are what you tweet: Ana- lyzing twitter for public health." in ICWSM, L. A. Adamic, R. A. Baeza-Yates, and S. Counts, Eds. The AAAI Press, 2011. [12] X. An, A. R. Ganguly, Y. Fang, S. B. Scyphers, A. M. Hunter, and J. G. Dy, "Tracking climate change opinions from twitter data." Workshop on Data Science for Social Good, 2014. [13] A. Tumasjan, T. Sprenger, P. Sandner, and I. Welpe, "Pre- dicting elections with twitter: What 140 characters reveal about political sentiment," in Proceedings of the Fourth International AAAI Conference on Weblogs and Social Media, 2010, pp. 178 -- 185. [14] P. Barbera, "Birds of together: Bayesian ideal point estimation using twitter data," Political Analysis, vol. 23, pp. 76 -- 91, September 2014. the same feather tweet [15] B. Hecht, L. Hong, B. Suh, and E. H. Chi, "Tweets from justin bieber's heart: the dynamics of the location field in user profiles." in CHI, D. S. Tan, S. Amershi, B. Begole, W. A. Kellogg, and M. Tungare, Eds. ACM, 2011, pp. 237 -- 246. [16] D. Davidov, O. Tsur, and A. Rappoport, "Enhanced sentiment learning using twitter hashtags and smileys," Coling 2010: Poster Volume, pp. 241 -- 249, 2010. [17] C. English. see (2012, u.s.-china February) Americans, opinion friendly. Gallup. leaders [Online]. Available: http://www.gallup.com/poll/152618/ americans-opinion-leaders-china-ties-friendly.aspx?version= print ties as
1711.08243
1
1711
2017-11-22T12:00:54
Improving local clustering based top-L link prediction methods via asymmetrical link clustering information
[ "cs.SI", "physics.soc-ph" ]
Networks can represent a wide range of complex systems, such as social, biological and technological systems. Link prediction is one of the most important problems in network analysis, and has attracted much research interest recently. Many link prediction methods have been proposed to solve this problem with various technics. We can note that clustering information plays an important role in solving the link prediction problem. In previous literatures, we find node clustering coefficient appears frequently in many link prediction methods. However, node clustering coefficient is limited to describe the role of a common-neighbor in different local networks, because it can not distinguish different clustering abilities of a node to different node pairs. In this paper, we shift our focus from nodes to links, and propose the concept of asymmetric link clustering (ALC) coefficient. Further, we improve three node clustering based link prediction methods via the concept of ALC. The experimental results demonstrate that ALC-based methods outperform node clustering based methods, especially achieving remarkable improvements on food web, hamster friendship and Internet networks. Besides, comparing with other methods, the performance of ALC-based methods are very stable in both globalized and personalized top-L link prediction tasks.
cs.SI
cs
Improving local clustering based top-L link prediction methods via asymmetric link clustering information Zhihao Wu,∗ Youfang Lin,† and Yiji Zhao Beijing Key Lab of Traffic Data Analysis and Mining, School of Computer and Information Technology, Beijing Jiaotong Univerisy, Beijing 100044, People's Republic of China Hongyan Yan User and Market Research Department, China Mobile Research Institute, Beijing 100032 Networks can represent a wide range of complex systems, such as social, biological and tech- nological systems. Link prediction is one of the most important problems in network analysis, and has attracted much research interest recently. Many link prediction methods have been proposed to solve this problem with various technics. We can note that clustering information plays an important role in solving the link prediction problem. In previous literatures, we find node clustering coefficient appears frequently in many link prediction methods. However, node clustering coefficient is limited to describe the role of a common-neighbor in different local networks, because it can not distinguish different clustering abilities of a node to different node pairs. In this paper, we shift our focus from nodes to links, and propose the concept of asymmetric link clustering (ALC) coefficient. Further, we improve three node clustering based link prediction methods via the concept of ALC. The experimental results demonstrate that ALC-based methods outperform node clustering based methods, especially achieving remarkable improvements on food web, hamster friendship and Internet networks. Besides, comparing with other methods, the performance of ALC-based methods are very stable in both globalized and personalized top-L link prediction tasks. I. INTRODUCTION Networks have been widely used to represent a large variety of complex systems, such as social, biologi- cal and technological systems [1–5]. Nodes represent entities in these systems and directed/undirected and weighted/unweighted links express relations among en- tities. It has been found that networks extracted from different fields possess some common features, such as power-law degree distribution, community structures and so on. The study of complex networks has become a sub- stantial area of multidisciplinary research involving in- formatics, social sciences, physics, biology, mathematics, and other applied sciences. In many cases, the data sets collected from various sys- tems just reflect a part of reality. That means some links in observed networks are missing or may be able to ap- pear in the future. This problem corresponds to one of the most critical tasks in network analysis, i.e. link pre- diction, which aims at estimating the likelihood of the existence of a link between a pair of nodes based on avail- able network information [6, 7]. Predicting missing links has great value in many different applications. Some- times, people concern latent links that are most likely to exist from the perspective of global network. For ex- ample, in the field of biology, as our knowledge of many ∗ [email protected][email protected] biological systems is very limited, using predicted top- L links to guide the laboratory experiments rather than blindly checking all possible interactions will greatly re- duce the experimental costs. While in some other cases, we want to predict or recommend personalized latent links for different nodes. For instance, social networking sites need to recommend new friends for different users to support better user experience or boost users' activity. Link prediction in complex networks is an open issue and studied by researchers from disparate scientific com- munities in recent years. To solve this problem, two kinds of information is usually employed, including property and topological structure information. Property informa- tion can be utilized by many machine learning algorithms and very good results can be achieved [8, 9]. However, in some cases, property information is hard to be accessed because of privacy issue or reliability of collected data. Therefore, a kind of methods focus on solely topological information. Some other methods also consider the tem- poral uncertainty property of dynamic social networks [10]. Similarity-based framework is one of the most popu- lar methods to solve link prediction problem [6, 7]. In this framework, each predicted pair of nodes is assigned a score to estimate the similarity between two nodes. A bunch of this kind of approaches has been developed, including methods based on local or global structure in- formation. In the early stage, some very simple similarity indices are used to predict missing links. PA index [11] is de- fined as the product degrees of two nodes. CN index [12] counts the number of common-neighbors and JC [13] is the normalization of CN. AA [14] and RA [15] improve the resolution of CN and achieve better pre- diction accuracy. Recently, researchers proposed some more advanced common-neighbor based methods. Com- bining the idea of link community, Cannistraci et al. de- signed a series of CAR-based similarity indices to improve classical similarity indices with links between common- neighbors [16]. Some recent literatures show that CRA index, which is a variant of RA index, always performs best in all CAR-based indices. However, CAR-based methods are not efficient enough and need to be imple- mented with parallel technics to solve large networks. For higher accuracy, some global and quasi-local meth- ods are proposed, such as Kaza [17], SimRank [18], Hit- ting Time [19], Average Commute Time [20], Local Path [21], Transferring Similarity [22], Matrix Forest Index [23] and so on. Utilizing more information, these meth- ods achieve better prediction results, but also cost more computation time. Besides, there are also some sophis- ticated methods, such as HSM [24] and SBM [25], which employ maximum likelihood estimation technics. Lu et al proposed a structural perturbation method and con- cept of structural consistency, which can be used to in- vestigate the link predictability [26] of networks. Pan et al proposed an algorithmic framework [27], where a net- works probability is estimated according to a predefined structural Hamiltonian, and the existence score of a non- observed link is quantified by the conditional probability of adding the focal link to the network while the spuri- ous probability of an observed link is quantified by the conditional probability of deleting the link. The study of link prediction is also closely related to the problem of network evolving mechanisms [28, 29]. A recently proposed triangle growing network model can generate networks with various key features that can be observed in most real-world networks, with only two kinds of triangle growth mechanisms [30]. It indicates tri- angle information has crucial importance in link forma- tion. A network index, called node clustering coefficient, is defined by the number of triangles passing through a node divided by the possible maximal number of trian- gles. And it has been proven node clustering information has good effectiveness in predicting missing links even under a very simple common-neighbor based framework [31]. estimates the CCLP index [31] contribution of common-neighbors in forming a link between a pair of nodes by node clustering coefficient directly, and achieves good prediction results. Based on Bayes theory, LNBCN [32] utilizes a local Naıve Bayes model to differentiate the role of neighboring nodes. The final form of LNBCN in- dex is a function of clustering coefficient plus a function of network density. Mutual information (MI) index [33] is defined as the conditional self-information of the event that a pair of nodes are connected when their common- neighbors are given. In MI index, clustering coefficient 2 can estimate the conditional probability of the existence of a link between a pair of nodes belonging to the ego- network of a given common-neighbor. From the final equations of these indices, node clustering coefficient al- ways plays a key role. However, node clustering coeffi- cient cannot distinguish different clustering abilities of a node to different node pairs. Unfortunately, real situa- tions always dissatisfy this assumption. One node may play very different roles in forming different links in dif- ferent circles. This is the main problem that we want to solve in this paper. Besides, motif structures (can be considered as an ex- tension from clustering) in directed networks are also explored in solving link prediction problem. Zhang et al proposed a hypothesis named potential theory, which assumes that every directed link corresponds to a de- crease of a unit potential and subgraphs with definable potential values for all nodes are preferred. Combining the potential theory with the clustering and homophily mechanisms, it is deduced that the Bi-fan structure con- sisting of 4 nodes and 4 directed links is the most favored local structure in directed networks [34]. Their simula- tion results demonstrated that clustering (motif) infor- mation has critical importance for link prediction even in directed networks. In this paper, we propose and investigate the power of local asymmetric clustering information to improve globalized and personalized top-L link prediction accu- racy. As mentioned above, node clustering coefficient has some drawbacks in estimating the contribution of common neighbor nodes. Therefore, we shift our focus from node clustering to link clustering information. To different end nodes of a link, we define asymmetric link clustering coefficient, and our further studies show that the asymmetric link clustering information can be em- ployed to predict top-L latent links with better perfor- mance than node clustering information. The rest of this paper is organized as follows: Sec- tion II gives some fundamental definitions and concept of asymmetric link clustering. Section III presents three modified asymmetric link clustering information based link prediction methods. Section IV demonstrates the experimental results. Section V offers conclusions and related prospects in the future work. II. DEFINITION Definition 1. Graph- A network can be represented by a graph G = (V, E), where V is the set of nodes and E is links, i.e. unconnected node pairs. the set of links. eE is a set representing all non-existent Definition 2. Latent links - Each node-pair in eE will be assigned a similarity score and sorted in descend order. The latent links at the top of the rank are most likely to exist. Definition 3. Node Clustering (NC) coefficient- The clustering coefficient of a node is defined as the number of triangles passing through a node divided by possible maximum number of triangles passing through this node. It can be calculated by equation (1). Cz = tz kz(kz − 1)/2 (1) where tz is the number of triangles passing through node z, and kz is the degree of node z. Definition 4. Asymmetric link clustering (ALC) coefficient- The motivation of link clustering coefficient is similar with that of node clustering coefficient. In gen- eral, it can be defined as the number of triangles pass- ing through a link divided by possible maximum number of triangles [35]. However, in link prediction problem, we always have more interests in the possible maximum number of triangles related to one of the two end nodes, because different end-nodes may play different roles. For example, one end node may belong to the predicted pair of nodes, and the other one may belong to common- neighbors of the predicted pair of nodes. Therefore, we propose an asymmetric link clustering coefficient defined by equation (2). LCx,z = Γ(x) ∩ Γ(z) kz − 1 (2) where Γ(x) denotes the set of neighbors of node x and A is the number of items in set A. It is obvious that LCx,z is not equal to LCz,x, unless the degree of node x is equal to that of node z. The asym- metric link clustering coefficient measures the clustering ability of a link from the perspective of each of its two end-nodes. In this work, we will investigate the crucial importance to differentiate the clustering ability of a link from the perspective of its two end-nodes in predicting missing links. In this paper, several classical and advanced local link prediction methods are compared and analyzed. Their definitions are given as follows: (1) CN (Common Neighbors) index [12] counts the number of common neighbors for a pair of nodes. In gen- eral, more common neighbors indicate larger probability to form/exist a link between two nodes. The definition of CN is given in equation (3). sCN xy = Γ(x) ∩ Γ(y) (3) (2) LocalPath index [21] considers the information of the next nearest neighbors, which is a kind of extension of CN index. sLocalP ath xy = (A2)xy + ε(A3)xy (4) where ε is a parameter. (A2)xy and (A3)xy are the num- bers of different paths with length 2 and 3 connecting x 3 and y, respectively. In our experiments, ε is fixed as 0.01, which is recommended by its authors. (3) RA (Resource Allocation) [15] is an index based on common neighbors, and the motivation comes from resource allocation dynamics on complex systems. For a pair of unconnected nodes, x and y, the node x can send some resource to y, with their common neighbors playing the role of transmitters. In the simplest case, assume that each transmitter has a unit of resource, and will equally distribute the resource to all its neighbors. xy = X sRA z∈Γ(x)∩Γ(y) 1 kz (5) (4) CRA index [16] is a revised version of RA index based on link community paradigm, which includes some additional consideration on the link structure between common-neighbors. The definition of CRA is xy = X sCRA z∈Γ(x)∩Γ(y) γ(z) Γ(z) (6) where γ(z) refers to the subset of neighbors of node z that are also common neighbors of nodes x and y. (5) CCLP index [31] utilizes node clustering coefficient (equation (1)) to estimate the contribution of common neighbors directly. Its definition is in equation (7). sCCLP xy = X Cz z∈Γ(x)∩Γ(y) (7) (6) LNBCN index [32] is inferred according to the Bays theory. The final definition of LNBCN is given in equa- tion (8). It consists two parts: the first part is a function of node clustering coefficient and the second part is a function of network density. sLN BCN xy = X (log( z∈Γ(x)∩Γ(y) Cz 1 − Cz ) + log( 1 − ρ ρ )) (8) where ρ is the network density and is defined in equation (9). ρ = E V (V − 1)/2 (9) (7) MI (Mutual Information) index [33] is defined based on information theory as shown in equation (10). If we utilize network density to infer self-information I(A1 xy) and node clustering coefficient to infer conditional self-information I(A1 xyz), then the mutual information I(A1 xy; z) can be represented as equation (11). xy = X sM I z∈Γ(x)∩Γ(y) I(A1 xy; z) − I(A1 xy) (10) I(A1 xy) − I(A1 xy; z) = I(A1 xyz) = −logP (ρ) + logP (Cz); (11) CN index is the most basic common-neighbor based method. LocalPath index improves CN from the perspec- tive of considering longer path information, while RA and CCLP improve CN from the perspective of distinguish- ing the function of different common-neighbors. CRA further improves RA with more local link structure in- formation. LNBCN and MI consider the link prediction problem under different theories, while the final forms also belong to common-neighbor based local methods. III. METHODS From the three last introduced link prediction meth- ods, i.e. CCLP, LNBCN and MI, we can observe that clustering information in solving link prediction prob- lem has crucial importance. Although the three meth- ods start from different perspectives, clustering coeffi- cient plays important role in the final definitions. How- ever, node clustering coefficient utilized by these meth- ods is universally invariant. That means these methods consider each node playing the same role for predicting different latent links in different local networks. Actually, a node can belong to different circles or communities and play different roles. Ahn et al. has proposed the concept of link community several years ago [36]. They found that starting from the view of links information that is more diverse could be achieved, such as overlapping com- munity structures. Therefore, we focus on the power of asymmetric link clustering information in predicting globalized and per- sonalized top-L missing links. The definition of asymmet- ric link clustering coefficient has been given in equation (2). The so-called asymmetry means that the clustering coefficient of a link can be different when its two end- nodes play different roles. Based on this idea, we will give three modified clustering based link prediction methods under three different frameworks in the following subsec- tions. A. Asymmetric topological structure based method In this subsection, we present a simple similarity index based on asymmetric link clustering information under the framework of common-neighbors. In this method, the similarity is first estimated from the perspective of two different seed-nodes, respectively. Here two seed-nodes correspond to a predicted pair of nodes. As shown in Fig. 1, there are three common-neighbors between seed-node x and y. For each seed-node, there are three links connecting common-neighbors, respectively. The new method, called ACC, focuses on the clustering information of these links existing between seed-nodes 4 and common-neighbors. A larger link clustering coeffi- cient indicates larger probability of forming a triangle or existing a link between seed nodes. The similarity can be defined as the summation of asymmetric link clus- tering coefficient of links connecting one seed node and common-neighbors. It can be noted that the similarity of node pair (x, y) can be estimated from the view of either node x or node y. For example, we can define the similarity of (y, x) by equation (12). In this equation, only clustering informa- tion of links, i.e. the red heavy links in Fig. 1, is used. sim(y, x) = X z∈Γ(x)∩Γ(y) LCy,z (12) It is obvious that sim(x, y) is not equal to sim(y, x) from the definition of equation (12). Thus, when choos- ing top-L latent links in predicting procedure, we can rank all asymmetric node pairs according to their sim- ilarities. Since we only predict undirected links, either sim(x, y) or sim(y, x) is ranked in top-L, the undirected node pair (x, y) is judged as a missing link. In other words, the result is only dominated by the higher value between sim(x, y) and sim(y, x). Therefore, the final ACC similarity index only chooses the higher similarity. The definition is given in equation (13). xy = max{ X sACC LCx,z, X LCy,z} (13) z∈Γ(x)∩Γ(y) z∈Γ(x)∩Γ(y) B. Asymmetric Local Naıve Bays based method Local Naıve Bays based model is a probability-based method [32]. As shown in equation (14), the key problem of this method is to define the probability of existing a link or not for a given sub-network regarding to a pair of seed-nodes, properly. sim(x, y) = P (A1 P (A0 xyGxy) xyGxy) (14) xy and A0 where A1 xy indicate the event of existing a link or not between node x and y, respectively. Gxy indicates the sub-network regarding to x and y. In our method, we continue to solve this problem utilizing asymmetric link clustering information. Thus, the two conditional probabilities are defined as equation (15) and (16). Here Lx = {exz exz ∈ E , z ∈ Γ(x) ∩ Γ(y)}. P (A1 xyLx) = P (A0 xyLx) = xy) P (A1 P (Lx) Y e∈Lx xy) P (A0 P (Lx) Y e∈Lx P (eA1 xy) (15) P (eA0 xy) (16) 5 c1 c2 x c3 y seed node common-neighbor of seed nodes other neighbors of common-neighbor z FIG. 1. Illustration of asymmetric link clustering information based similarity index. Substituting equation (15) and (16), we can get sim(x, y) = P (A1 P (A0 xy) xy) Y z∈Γ(x)∩Γ(y) P (A0 P (A1 xy)· P (A1 xy)· P (A0 xyexz) xyexz) P (A1 xy). Since P (A1 (17) xy) can be estimated by the whole network den- sity as defined in equation (9), and P (A0 xy) is equal to 1 − P (A1 xy) is the same for all pairs of nodes, it does not affect the rank of latent links and can be removed in the final definition of similarity index. P (A1 xyexz) can be estimated by asymmetric link clustering coefficient LCxz, and P (A0 xyexz) is equal to 1 − P (A1 xy)/P (A0 xyexz). At last, the situation is the same with ACC. sim(x, y) is not equal to sim(y, x), but the results are only influ- enced by the higher value. Equation (18) shows the final form of ALNB index. sALN B xy = max{ Y z∈Γ(x)∩Γ(y) Y z∈Γ(x)∩Γ(y) P (A0 P (A1 xy)· P (A1 xy)· P (A0 xyexz) xyexz) , P (A0 P (A1 xy)· P (A1 xy)· P (A0 xyeyz) xyeyz) (18) } Mutual information based method defines the similar- ity as a conditional self-information, as shown in equation (21) [33]. Here, we still consider Lx = {exz exz ∈ E , z ∈ Γ(x) ∩ Γ(y)} as the part of Gxy. sim(x, y) = −I(A1 xyGxy) = I(A1 xy; Lx) − I(A1 xy) (21) Here P (A1 In Ref. xy) can be estimated by the whole network [33], this density as defined in equation (9). probability is defined by a more complex method, but we find these two kinds of definitions of P (A1 xy) only perform better than each other on different networks. The authors of MI index also recommended this method in their another work [37]. Therefore, the part of I(A1 xy) can be removed, because it is the same for all pairs of nodes, and does not affect the final rank of latent links. Thus, equation (21) can be simplified as equation (22). sim(x, y) = X z∈Γ(x)∩Γ(y) I(A1 xy; exz) (22) Then we try to calculate the above mutual informa- xy; exz) can be rep- tion. According to equation (20), I(A1 resented as I(A1 xy; exz) = I(A1 xy) − I(A1 xyexz) (23) C. Asymmetric Mutual Information based method In this subsection, we modify the mutual information based method via the concept of ALC. First, we intro- duce the definition of self-information and mutual infor- mation. In information theory, self-information is defined in equation (19), and the conditional self-information can be calculated by self-information and mutual information as shown in equation (20). Thus, we need to estimate the probability P (A1 xyexz), which can be calculated by the link clustering coeffi- cient LCxz. At last, we still choose higher value between sim(x, y) and sim(y, x) to form the final definition of AMI index, which is given by equation (24). xy = max{ X sAM I I(A1 xy; exz), X I(A1 xy; eyz)} z∈Γ(x)∩Γ(y) z∈Γ(x)∩Γ(y) (24) I(x) = −logP (x) I(xy) = I(x) − I(x; y) (19) (20) IV. EXPERIMENTS In this section, we will give the experimental results of the proposed asymmetric link clustering (ALC) based link prediction methods on 12 networks collected from various fields. Seven neighborhood based link prediction methods are compared, including three corresponding NC based methods and four other representative meth- ods. Please note in most related literatures, authors only give the results of their methods in solving globalized link prediction problem, here we demonstrate the per- formance of these methods in predicting both globalized and personalized top-L latent links. A. Data sets In the following experiments, we will test our meth- ods on 6 small networks (the number of nodes is less than 1000) and 6 large networks (the number of nodes is more than 1000) from social, biological and technological fields. Except local methods, we also compare our meth- ods with 2 global link prediction methods, i.e. HSM [24] and SBM [25] on 6 small networks. Dolphins [38] is a dolphin social network, in which an edge represents fre- quent association between a pair of dolphins. Mouse [39] is a mouse neural network and the synaptic connections between neurons are represented as links. In Macaque [40] network, cortical connectomes are modeled as nodes and links. Food [41] is a food web network. Celegans [42] is a neural network of the nematode Caenorhabditis ele- gans. Yeast [43] is a protein-protein interaction network of yeast. Hamster [44] is a friendship network between users of the website hamsterster.com. PB [45] is a po- litical blog network. USAir [46] is a network of US air transportation system. INT [47] is a network of router- level topology of the Internet. P2P [48] is a peer-to-peer file sharing network. Scimet [49] is a network of articles from or citing Scientometrics. The statistics of these net- works are given in Table I. Directed links are treated as undirected ones, and self-loops are removed. hki hCi hLCi r hdi E Nets V H 1.327 0.259 0.118 -0.044 3.357 5.129 159 Dolphins 62 1.967 4.111 1.289 0.216 0.108 -0.516 37 Mouse 18 1.771 32.234 1.238 0.774 0.585 -0.151 1515 Macaque 94 1.776 32.422 1.237 0.335 0.113 -0.112 Food 128 2075 2.455 14.465 1.801 0.292 0.081 -0.163 Celegans 297 2148 USAir 2.738 12.807 3.464 0.625 0.37 -0.208 332 2126 Hamster 1788 12476 3.453 13.955 3.264 0.143 0.03 -0.085 PB 1222 16714 2.738 27.355 2.971 0.32 0.103 -0.221 3.476 0.306 0.273 0.454 2375 11693 5.096 9.847 Yeast 5.503 0.012 0.009 -0.138 5022 6258 INT 6.449 2.492 2.676 0.011 0.002 0.036 6299 20776 4.642 6.597 P2P Scimet 2678 10368 4.18 7.743 2.427 0.174 0.049 -0.033 TABLE I. The basic topological features of twelve real world networks. V and E are the number of nodes and links. hdi is average shortest distance. hki is average degree. H is the degree heterogeneity, defined as H = hk hk2i . hCi and hLCi are average node and link clustering coefficient, and r is the assortative coefficient [50]. 2i 6 B. Evaluation To evaluate the performance of compared methods in predicting top-L latent links, we employ two estimators: precision and AUP. The preparations for the two cho- sen estimators are the same. First, the link set E of a network is randomly divided into two parts: Et and Ep. The training set Et is used as the known topological in- formation, and the probe set Ep is used as the test set. We can get Et ∪ Ep = E and Et ∩ Ep = null. To make sure that the training set contains true structure infor- mation, we only set 10% of links as the test links, because removing too many links from the network may destroy the structure of the original network. We employ a commonly used way to estimate the ef- fectiveness of the top-L latent link prediction methods. First we calculate the similarity of all unconnected node pairs, including those belonging to probe set Ep and nonexistent link set eE. Then all these latent links are ranked in descend order. Definition 5. Precision- The precision is defined as the ratio of relevant items selected to the number of items selected [51]. That means if we take top L links as the predicted ones, among which Lr links are right, then the precision can be defined as equation (25). Higher preci- sion indicates higher prediction accuracy. In globalized link prediction, L is set to 20 or 100 for networks with less or more than 1,000 links. In personalized link predic- tion, L is set to 5, and the final precision is the average of precisions of all nodes. precision = Lr L (25) Definition 6. AUP- AUP is defined as the Area Under Precision curve [16]. Here, precision curve is achieved by using ten different values of L, which are 10,20,...,100 for networks with more than 1000 links and 2, 4,...,20 for networks with less than 1000 links in globalized link pre- diction and are 1, 2,...,5 in personalized link prediction. C. Globalized top-L latent link prediction In this subsection, we give the experimental results of these methods in predicting globalized top-L latent links. The so-called "globalized" here means the top- L latent links are selected from the perspective of the whole network. For example, in biology experiments, we need to find some most probable candidate interactions between proteins to check in the whole system. Figure 2 shows the globalized link precision results of these methods on 12 networks. On the top six small net- works, 12 link prediction methods are compared, includ- ing two global methods, i.e. HSM and SBM. It can be noted that asymmetric link clustering information based methods perform better than their corresponding node clustering based methods in most cases, and the lowest accuracy attained by asymmetric link clustering based methods is even always higher than the highest accuracy attained by other node clustering based methods. Com- paring with global methods, ALC-based methods achieve better results on four of six networks. Only on Food net- work, global methods demonstrate absolute advantage, while on other small networks, ALC-based methods do not perform worse than global methods significantly. In Fig. 2, the given straight line indicates the highest accuracy of all other non-ALC based local link prediction methods. In all 12 tested networks, ALC based meth- ods almost achieve all best results among local methods. In eight networks, the best results of ALC based meth- ods are significantly better than the highest accuracy of non-ALC based local methods. Especially for food web, Hamster and INT networks, the ratios improved by ALC-based methods come up to more than 100% com- paring with their counterparts. In other four networks, ALC based methods achieve similar precision with the best results of other seven compared local link prediction methods. To further investigate the dependence of globalized link prediction accuracy on the value of L, we plot the preci- sion curves on each network with various values of L and the corresponding AUP results in Fig. 3. To make the figure clearer, we only give the precision curve of three ALC based methods and their corresponding NC based methods. From the results in Fig. 3, we find that the change of L does not affect the improvements made by asymmetric link clustering information in most networks. The above analysis only focuses on top-100 candidate links. To further check the power of ALC based methods, we investigate the needed length of candidates L to hit K links on six relatively large networks in Fig. 4. In this experiment, K is set from 1 to 100, which means the observed scope of candidates is largely extended, and the differences among ALC and NC based methods are more notable. For a same value of K, a smaller L indicates better performance. Overall, the advantages of ALC based methods are very stable. With the increase of K, the improvements made by ALC based methods always become larger. For some networks, such as Yeast network, when K is less than 60, there is almost no difference between the re- sults of ALC and NC based methods. However, when K is larger than 60, ALC based methods demonstrate remarkable advantages. This result indicates the value of parameter L does not influence the advantage of ALC based methods, and a larger L always makes the improve- ments even more remarkable in globalized top-L latent link prediction. D. Personalized top-L latent link prediction In this subsection, we demonstrate the experimental results of these methods in personalized top-L latent link prediction. Personalized link prediction aims at predict- 7 ing latent links for each node, respectively. For example, social networking sites always need to recommend new friends for their users. In this scenario, all users not con- necting to a specific user will be sorted according their similarities with this node in descend order, and top L selected users are recommended to this user. In the following analysis, the given accuracy is the average of predicting precision of all nodes. In our ex- periments, since the links in probe set Ep are randomly selected, some nodes may have more links removed and some other nodes may have fewer missing links. Here the value of parameter L just defines the maximal number of selected links. If the number of removed links is smaller than L, L will be modified as the number of removed links for this node. Please note different strategies can be adopted here. We believe that as long as the adopted strategy is consistent, the results are fair to each com- pared method. Other configurations are the same with the experiments in globalized link prediction. Fig. 5 demonstrates the personalized link prediction accuracy on 12 networks. On the top six small networks, we compare 12 methods, including HSM and SBM. The results are similar to those of globalized experiments, i.e. except on Food network, ALC-based methods do not per- form worse than global methods on most networks. We can also observe clear improvements made by ALC based methods to their corresponding NC based methods once again in most networks. In most cases, the best results are also achieved by ALC based methods, except on US- Air network, in which the classical RA index performs best. We can find another interesting phenomenon, i.e. for globalized link prediction, CRA index always performs very well in all non-ALC based methods, while for per- sonalized link prediction, LocalPath index always per- forms better than other non-ALC based methods. The predicting accuracy of CRA index in personalized link prediction has a significant drop. However, the perfor- mance of ALC based methods are always stably well in both globalized and personalized latent link predic- tion. That demonstrates the advantage of asymmetric link clustering information in predicting missing links. Fig. 6 gives the precision curves and AUP with the value of L from 1 to 5 for personalized link prediction. The results are even clearer than those in globalized link prediction are. In most cases, all precision curves of ALC- based methods have clearly higher positions than corre- sponding NC based methods. In Fig. 7, we also give the needed length of L to hit K links in personalized link prediction. Here K is set from 1 to 5. The results show that the performances of ALC based methods are very stable and not impacted by the chosen parameter L in personalized latent link prediction. 8 Mouse 0.8 0.6 Macaque 0.4 C C A P L C C B N L A N C B N L I M I M A 0.2 0.0 0.6 A R A R C M S H M B S N C h t a P l a c o L USAir 0.4 0.2 0.0 0.9 0.8 0.7 0.6 0.5 0.4 0.3 0.2 0.1 0.0 0.25 0.20 0.15 0.10 0.05 0.00 C C A P L C C B N L A N C B N L I I M M A N C A R h t a P l a c o L A R C M S H M B S Yeast I I M M A I I M M A C C A P L C C B N L A N C B N L C C A P L C C B N L A N C B N L A R A R C N C h t a P l a c o L Scimet A R A R C N C h t a P l a c o L 0.10 0.08 0.06 0.04 0.02 0.00 0.25 0.20 0.15 0.10 0.05 0.00 0.6 0.5 0.4 0.3 0.2 0.1 0.0 0.06 0.04 C C A P L C C B N L A N C B N L C C A P L C C B N L A N C B N L I I M M A A R C M S H M B S N C A R h t a P l a c o L Celegans N C A R h t a P l a c o L I I M M A A R C M S H M B S PB C C A P L C C B N L A N C B N L I I M M A A R A R C N C h t a P l a c o L P2P 0.20 0.15 n o i s i c e r p 0.10 0.05 0.00 n o i s i c e r p 0.6 0.5 0.4 0.3 0.2 0.1 0.0 0.20 0.15 n o i s i c e r p 0.10 0.05 0.00 0.5 0.4 0.3 0.2 n o i s i c e r p 0.1 0.0 Dolphins C C A P L C C B N L A N C B N L C C A P L C C B N L A N C B N L I I M M A I I M M A N C A R h t a P l a c o L A R C M S H M B S Food A R A R C M S H M B S N C h t a P l a c o L Hamster A R A R C N C h t a P l a c o L INT I I M M A C C A P L C C B N L A N C B N L C C A P L C C B N L A N C B N L 0.02 0.00 C C A P L C C B N L A N C B N L A R A R C N C h t a P l a c o L I I M M A I I M M A A R A R C N C h t a P l a c o L FIG. 2. Globalized Link prediction accuracy in 12 networks estimated by precision. E. Time costs V. CONCLUSIONS Table II gives the time costs of all compared link pre- diction methods. Since global methods have some effi- ciency limitation, they are only tested on small networks. ALC based methods demonstrate competitive efficiency with NC based methods. Each result is an average of 100 independent runs. Local clustering information is fundamental and im- portant in many areas, such as in estimating the proba- bility of existing a link in a specific local network. Thus estimating a specific local clustering degree properly be- comes a key problem. In this paper, we propose and investigate the power of asymmetric link clustering infor- mation in solving the link prediction problem. Previous 9 Dolphins P U A 0.20 0.15 0.10 0.05 ACC CCLP ALNB LNBCN AMI MI 0.3 Mouse 0.12 0.10 0.08 0.06 P U A 0.2 0.1 Macaque 0.8 0.7 0.6 0.5 P U A 0.95 0.90 0.85 0.80 0.75 0.70 0.65 0.60 0 5 10 15 20 0 5 10 15 20 0 20 40 60 80 100 Food L 0.4 0.3 0.2 0.1 P U A Celegans L 0.20 0.15 P U A 0.10 0.05 0.24 0.23 0.22 0.21 0.20 0.19 0.18 0.17 0.16 0.15 0.14 0.13 0.8 Yeast 0.7 0.6 L 0.8 0.7 0.6 0.5 P U A 0 20 40 60 80 100 0 20 40 60 80 100 0 20 40 60 80 100 Hamster L 0.2 0.1 P U A 0.0 L 0.6 0.4 0.2 P U A PB 0.8 0.7 0.6 0.5 0.4 USAir L P U A 0.8 0.7 0.6 0.5 1.0 0.9 0.8 0.7 0.6 0 20 40 60 80 100 0 20 40 60 80 100 0 20 40 60 80 100 INT L 0.5 0.4 0.3 0.2 0.1 P U A P2P L 0.04 0.03 P U A 0.02 0.01 0.00 0.050 0.045 0.040 0.035 0.030 0.025 0.020 Scimet L 0.2 P U A 0.1 0.30 0.28 0.26 0.24 0.22 0.20 0.18 0.16 0.14 0.12 0.10 20 40 60 80 100 0 20 40 60 80 100 0 20 40 60 80 100 L L L 0.5 0.4 0.3 0.2 0.1 0.8 0.6 0.4 0.2 0.3 0.2 0.1 0.0 0.7 0.6 0.5 0.4 0.3 0.2 n o i s i c e r p n o i s i c e r p n o i s i c e r p n o i s i c e r p 0.1 0 FIG. 3. Precision curves and AUP of ALC and their corresponding NC based methods for globalized link prediction. The columns of AUP, from left to right, are ACC, CCLP, ALNB, LNBCN, AMI and MI. literatures have verified the effectiveness of node cluster- ing information, but it is still limited. Because traditional node clustering coefficient can not measure the cluster- ing ability of a node to some specific node. To describe the local clustering information more specific, we propose the asymmetric link clustering coefficient. Employing the new measurement, we further give three ALC-based link prediction methods under different frameworks. To demonstrate the advantage of our methods, we per- form globalized and personalized top-L link prediction experiments on 12 networks drawn from various fields. Comparing with NC-based and other non-ALC based methods, ALC-based methods cannot only improve NC- based methods a lot, but also shows great stability in both tasks. While some other good non-ALC based methods, such as LocalPath and CRA indices, can only 10 3000 2500 2000 1500 1000 500 0 0 450 400 350 300 250 200 150 100 50 0 0 300 200 100 0 0 ALNB LNBCN Hamster 20 40 60 80 100 K ALNB LNBCN Yeast 20 40 60 80 100 K ALNB LNBCN 20 40 60 80 100 PB 3000 2500 2000 1500 1000 500 0 0 400 300 200 100 0 0 300 200 100 0 0 AMI MI Hamster 20 40 60 80 100 K AMI MI Yeast 20 40 60 80 100 K AMI MI 20 40 60 80 100 PB K K K ACC CCLP 20 40 60 80 100 P2P K ACC CCLP Scimet 20 40 60 80 100 K ACC CCLP 20 40 60 80 100 INT 25000 20000 15000 10000 5000 0 0 1500 1000 500 0 0 4000 3000 2000 1000 0 0 ALNB LNBCN 20 40 60 80 100 P2P K ALNB LNBCN Scimet 20 40 60 80 100 K ALNB LNBCN 20 40 60 80 100 INT 25000 20000 15000 10000 5000 0 0 1500 1000 500 0 0 2000 1500 1000 500 0 0 AMI MI 20 40 60 80 100 P2P K AMI MI Scimet 20 40 60 80 100 K AMI MI 20 40 60 80 100 INT K K K ACC CCLP 2500 2000 1500 1000 500 L Hamster 20 40 60 80 100 K ACC CCLP Yeast 20 40 60 80 100 K ACC CCLP 20 40 60 80 100 PB 0 0 400 350 300 250 200 150 100 50 0 0 300 200 100 0 0 25000 20000 15000 10000 5000 0 0 1500 1000 500 0 0 L L L L 2000 1500 L 1000 500 0 0 FIG. 4. The needed length of candidates (L) to hit K links for ALC and NC based methods in globalized link prediction on six relatively large networks. The horizontal axis K represents the number of latent links that an algorithm hits and the vertical axis L presents the average number of node pairs we need to observe in the whole rank of node pairs. perform well in one of globalized and personalized link prediction tasks at most. We believe that the main rea- son, why ALC-based methods achieve such stable im- provements, is that asymmetric link clustering measures more targeted local structural information for each can- didate pair of nodes. At last, we must say there is still a problem we cannot answer, i.e. when ALC-based methods can give definite improvements. Our experiments have shown that ALC- based methods outperform other compared methods in many networks with a significant improvement. However, for USAir network, ALC-based methods fail to perform better than their NC-based counter parts, though they do not perform worse either. Unfortunately, it is not easy to differentiate USAir with other networks from basic net- work statistics commonly used. Although USAir network shows a significantly high average clustering coefficient, ALC-based methods perform not bad on Macaque net- work, which has a even higher average clustering coeffi- cient than USAir network. In the future, we will make more efforts to try to answer this question, and we hope that more researchers will adopt ALC-based methods to analyze some other networks. It would be helpful to un- derstand the behavior of asymmetric link clustering in- formation better. 11 Mouse Macaque 0.6 0.4 0.2 0.0 0.5 0.4 0.3 0.2 0.1 0.0 0.4 0.3 0.2 0.1 0.0 C C A P L C C B N L A N C B N L C C A P L C C B N L A N C B N L C C A P L C C B N L A N C B N L 0.10 M I I M A N C h t a P l a c o L A R A R C M S H M B S USAir I I M M A A R A R C M S H M B S N C h t a P l a c o L Yeast I I M M A A R A R C N C h t a P l a c o L Scimet Dolphins C C A P L C C B N L A N C B N L C C A P L C C B N L A N C B N L I I M M A A R A R C M S H M B S N C h t a P l a c o L Food I I M M A A R A R C M S H M B S N C h t a P l a c o L Hamster 0.4 0.3 0.2 0.1 0.0 0.15 0.10 0.05 0.00 0.15 0.10 C C A P L C C B N L A N C B N L C C A P L C C B N L A N C B N L I M A I M A R A R C M S H M B S N C h t a P l a c o L Celegans I M I M A A R A R C M S H M B S N C h t a P l a c o L PB I I M M A C C A P L C C B N L A N C B N L A R A R C N C h t a P l a c o L INT 0.05 0.00 0.010 0.008 0.006 I I M M A A R A R C N C h t a P l a c o L P2P 0.3 0.2 n o i s i c e r p 0.1 0.0 0.35 0.30 0.25 0.20 0.15 0.10 0.05 0.00 0.07 0.06 0.05 0.04 0.03 0.02 0.01 0.00 0.15 n o i s i c e r p n o i s i c e r p 0.10 n o i s i c e r p 0.05 0.00 C C A P L C C B N L A N C B N L C C A P L C C B N L A N C B N L 0.004 0.002 0.000 C C A P L C C B N L A N C B N L A R A R C N C h t a P l a c o L I I M M A 0.05 0.00 C C A P L C C B N L A N C B N L A R A R C N C h t a P l a c o L I I M M A I I M M A A R A R C N C h t a P l a c o L FIG. 5. Personalized Link prediction accuracy in 12 networks estimated by precision. VI. ACKNOWLEDGMENTS This work is supported by the National Natural Sci- ence Foundation of China (Grants No. 61403023), State Education Commission - China Mobile Research Fund (Grants No. MCM20150513) and Fundamental Re- search Funds for the Central Universities (Grants No. 2017JBM027). [1] R. Albert and A.-L. Barab´asi, Reviews of modern physics [2] S. Boccaletti, V. Latora, Y. Moreno, M. Chavez, and 74, 47 (2002). D.-U. Hwang, Physics reports 424, 175 (2006). ACC CCLP ALNB LNBCN AMI MI 12 0.30 n o i s i c e r p 0.25 0.20 n o i s i c e r p 0.3 0.2 0.1 0.04 0.02 0.2 n o i s i c e r p 0.1 1 2 3 L 4 5 1 2 0.10 Hamster 0.06 0.04 0.02 P U A 0.08 0.06 0.00 n o i s i c e r p 0.25 PB 0.20 0.15 0.10 1 2 3 L 4 5 1 2 INT P U A 0.15 0.10 0.05 0.00 P2P 0.010 0.005 Dolphins 0.30 0.25 0.20 0.15 0.10 0.05 P U A 0.3 Mouse 0.2 0.1 1 2 3 L 4 5 1 2 0.2 P U A 0.1 3 L Macaque 0.7 0.6 0.5 0.4 0.3 0.2 0.1 P U A 0.7 0.6 0.5 4 5 1 2 3 4 5 Food 0.2 P U A 0.1 0.20 0.15 Celegans 0.15 Yeast L 0.4 0.3 0.2 0.1 P U A 0.5 0.4 0.3 P U A 0.10 0.05 3 L 0.20 0.15 P U A 0.10 0.05 3 L 0.010 0.005 P U A 0.000 4 5 1 2 4 5 3 L USAir 0.5 0.4 0.3 0.2 0.1 P U A 0.55 0.50 0.45 0.40 4 5 1 2 4 5 3 L 0.14 Scimet 0.10 P U A 0.05 0.00 0.12 0.10 0.0 1 2 3 L 4 5 1 2 0.000 4 5 1 2 3 L 4 5 3 L FIG. 6. Precision curves and AUP of ALC and their corresponding NC based methods for personalized link prediction. The columns of AUP, from left to right, are ACC, CCLP, ALNB, LNBCN, AMI and MI. [3] L. d. F. Costa, F. A. Rodrigues, G. Travieso, and P. R. [7] L. Lu and T. Zhou, Physica A: Statistical Mechanics and Villas Boas, Advances in Physics 56, 167 (2007). its Applications 390, 1150 (2011). [4] G. Bianconi, P. Pin, and M. Marsili, Proceedings of the National Academy of Sciences 106, 11433 (2009). [5] H.-W. Shen and A.-L. Barab´asi, Proceedings of the Na- tional Academy of Sciences 111, 12325 (2014). [6] D. Liben-Nowell and J. Kleinberg, Journal of the Amer- ican society for information science and technology 58, 1019 (2007). [8] M. Al Hasan, V. Chaoji, S. Salem, and M. Zaki, in SDM06: Workshop on Link Analysis, Counter-terrorism and Security (2006). [9] R. N. Lichtenwalter, J. T. Lussier, and N. V. Chawla, in Proceedings of the 16th ACM SIGKDD international con- ference on Knowledge discovery and data mining (ACM, 2010) pp. 243–252. 13 L 300 250 200 150 100 50 0 40 30 L 20 10 0 150 120 90 60 30 0 400 300 L L 200 L 100 0 150 120 90 60 30 0 40 30 L 20 10 0 ACC CCLP Hamster 4 5 1 2 3 K ACC CCLP 1 2 3 K Yeast 4 5 ACC CCLP 1 2 3 4 K PB 5 ACC CCLP 1 2 3 4 K P2P 5 ACC CCLP Scimet 1 2 3 4 5 K ACC CCLP 1 2 3 4 INT 5 300 250 200 150 100 50 0 40 30 20 10 0 150 120 90 60 30 0 400 300 200 100 0 150 120 90 60 30 0 40 30 20 10 0 ALNB LNBCN Hamster 1 2 3 4 5 K ALNB LNBCN 1 2 3 K Yeast 4 5 ALNB LNBCN 1 2 3 4 5 PB K ALNB LNBCN 1 2 4 3 K P2P 5 ALNB LNBCN Scimet 4 5 1 2 3 K ALNB LNBCN 1 2 3 4 INT 5 300 250 200 150 100 50 0 40 30 20 10 0 150 120 90 60 30 0 400 300 200 100 0 150 120 90 60 30 0 40 30 20 10 0 AMI MI Hamster 1 2 3 4 5 K AMI MI 1 2 3 K Yeast 4 5 AMI MI 1 2 3 4 K PB 5 AMI MI 1 2 3 4 K P2P 5 AMI MI 1 2 3 K Scimet 4 5 AMI MI 1 2 3 4 INT 5 K K K FIG. 7. The needed length of candidates (L) to hit K links for ALC and NC based methods in personalized link prediction on six relatively large networks. The horizontal axis K represents the number of latent links that an algorithm hits and the vertical axis L presents the average number of node pairs we need to observe in the whole rank of node pairs. [10] N. M. Ahmed and L. Chen, Information Sciences 331, 71, 623 (2009). 120 (2016). [11] M. E. Newman, Physical Review E 64, 025102 (2001). [12] F. Lorrain and H. C. White, The Journal of mathematical sociology 1, 49 (1971). [13] P. Jaccard, Bulletin de la Societe Vaudoise des Science Naturelles (1901). [16] C. V. Cannistraci, G. Alanis-Lobato, and T. Ravasi, Scientific reports 3, 1613 (2013). [17] L. Katz, Psychometrika 18, 39 (1953). [18] G. Jeh and J. Widom, in Proceedings of the eighth ACM SIGKDD international conference on Knowledge discov- ery and data mining (ACM, 2002) pp. 538–543. [14] L. A. Adamic and E. Adar, Social networks 25, 211 [19] F. Gobel and A. Jagers, Stochastic processes and their (2003). applications 2, 311 (1974). [15] T. Zhou, L. Lu, and Y.-C. Zhang, The European Phys- ical Journal B-Condensed Matter and Complex Systems [20] F. Fouss, A. Pirotte, J.-M. Renders, and M. Saerens, Knowledge and data engineering, ieee transactions on 19, ACC CCLP ALNB LNBCN AMI MI Nets Dolphins 0.001 0.001 0.001 Mouse 0.001 0.001 0.001 Macaque 0.002 0.002 0.003 Food 0.004 0.003 0.006 Celegans 0.009 0.006 0.014 USAir 0.007 0.006 0.012 Hamster 0.117 0.112 0.211 0.131 0.105 0.198 PB 0.123 0.116 0.224 Yeast 0.236 0.150 0.706 INT 0.439 0.380 1.280 P2P Scimet 0.145 0.143 0.329 0.001 0.001 0.003 0.005 0.012 0.011 0.178 0.190 0.113 0.231 0.610 0.201 0.001 0.001 0.001 0.001 0.001 0.001 0.001 0.001 0.003 0.002 0.001 0.002 0.005 0.004 0.002 0.005 0.012 0.006 0.003 0.013 0.009 0.007 0.002 0.010 0.162 0.076 0.035 0.215 0.152 0.088 0.041 0.214 0.166 0.075 0.040 0.094 0.507 0.223 0.138 0.146 0.922 0.412 0.250 0.538 0.251 0.109 0.060 0.191 CN LocalPath RA CRA 0.001 0.775 0.001 0.059 0.001 1.335 0.002 2.672 0.003 17.934 0.003 21.763 0.046 706.590 0.047 303.530 0.066 1133.70 0.208 4956.69 0.387 7947.25 0.119 1862.38 14 27.541 5.834 HSM SBM 8.005 1.195 26.518 284.850 43.386 902.276 262.40 4117.28 358.76 4674.01 - - - - - - - - - - - - TABLE II. Time costs of all compared methods on 12 networks (in seconds). The results are average of 100 independent runs. 355 (2007). [21] L. Lu, C.-H. Jin, and T. Zhou, Physical Review E 80, 046122 (2009). [22] D. Sun, T. Zhou, J.-G. Liu, R.-R. Liu, C.-X. Jia, and B.-H. Wang, Physical Review E 80, 017101 (2009). [23] P. Y. Chebotarev and E. Shamis, Avtomatika i Tele- mekhanika , 125 (1997). [24] A. Clauset, C. Moore, and M. E. Newman, Nature 453, 98 (2008). [25] R. Guimer`a and M. Sales-Pardo, Proceedings of the Na- tional Academy of Sciences 106, 22073 (2009). [26] L. Lu, L. Pan, T. Zhou, Y.-C. Zhang, and H. E. Stanley, Proceedings of the National Academy of Sciences 112, 2325 (2015). [27] L. Pan, T. Zhou, L. L, and C.-K. Hu, Scientific reports 6, 22955 (2016). [28] W.-Q. Wang, Q.-M. Zhang, and T. Zhou, EPL (Euro- physics Letters) 98, 28004 (2012). [29] Q.-M. Zhang, X.-K. Xu, Y.-X. Zhu, and T. Zhou, Sci- [38] D. Lusseau, K. Schneider, O. J. Boisseau, P. Haase, E. Slooten, and S. M. Dawson, Behavioral Ecology and Sociobiology 54, 396 (2003). [39] D. D. Bock, W.-C. A. Lee, A. M. Kerlin, M. L. An- dermann, G. Hood, A. W. Wetzel, S. Yurgenson, E. R. Soucy, H. S. Kim, and R. C. Reid, Nature 471, 177 (2011). [40] R. Kotter, Neuroinformatics 2, 127 (2004). [41] R. Ulanowicz, C. Bondavalli, and M. Egnotovich, Annual Report to the United States Geological Service Biological Resources Division Ref. No.[UMCES] CBL , 98 (1998). [42] D. J. Watts and S. H. Strogatz, nature 393, 440 (1998). [43] D. Bu, Y. Zhao, L. Cai, H. Xue, X. Zhu, H. Lu, J. Zhang, S. Sun, L. Ling, N. Zhang, et al., Nucleic acids research 31, 2443 (2003). [44] KONECT, Hamsterster friendships unique network dataset (2015). [45] L. A. Adamic and N. Glance, in Proceedings of the 3rd international workshop on Link discovery (ACM, 2005) pp. 36–43. entific reports 5, 10350 (2015). [46] V. Batageli and A. [30] Z. Wu, G. Menichetti, C. Rahmede, and G. Bianconi, Scientific reports 5, 10073 (2015). datasets, lj.si/pub/networks/data/mix/usair97.net," (). available at Mrvar, "Pajek http://vlado.fmf.uni- [31] Z. Wu, Y. Lin, J. Wang, and S. Gregory, Physica A: Statistical Mechanics and its Applications 452, 1 (2016). [32] Z. Liu, Q.-M. Zhang, L. Lu, and T. Zhou, EPL (Euro- physics Letters) 96, 48007 (2011). [33] F. Tan, Y. Xia, and B. Zhu, PloS one 9, e107056 (2014). [34] Q.-M. Zhang, LLinyuan, W. Wen-Qiang, and Z. Tao, [47] N. Spring, R. Mahajan, and D. Wetherall, in ACM SIGCOMM Computer Communication Review, 4 (ACM, 2002) pp. 133–145. [48] J. Leskovec, J. Kleinberg, and C. Faloutsos, ACM Trans- actions on Knowledge Discovery from Data (TKDD) 1, 2 (2007). PloS one 8, e55437 (2013). [49] V. Batageli and A. Mrvar, "Pajek http://vlado.fmf.uni- [35] J. Wang, M. Li, H. Wang, and Y. Pan, Computational Biology and Bioinformatics, IEEE/ACM Transactions on 9, 1070 (2012). datasets, lj.si/pub/networks/data/cite/scimet.zip," (). available at [50] M. E. Newman, Physical review letters 89, 208701 [36] Y.-Y. Ahn, J. P. Bagrow, and S. Lehmann, Nature 466, (2002). 761 (2010). [37] B. Zhu and Y. Xia, Scientific reports 5, 13707 (2015). [51] J. L. Herlocker, J. A. Konstan, L. G. Terveen, and J. T. Riedl, ACM Transactions on Information Systems (TOIS) 22, 5 (2004).
1601.02465
1
1601
2016-01-11T14:55:16
The Hayastan Shakarian cut: measuring the impact of network disconnections
[ "cs.SI" ]
In this article we present the Hayastan Shakarian (HS), a robustness index for complex networks. HS measures the impact of a network disconnection (edge) while comparing the sizes of the remaining connected components. Strictly speaking, the Hayastan Shakarian index is defined as edge removal that produces the maximal inverse of the size of the largest connected component divided by the sum of the sizes of the remaining ones. We tested our index in attack strategies where the nodes are disconnected in decreasing order of a specified metric. We considered using the Hayastan Shakarian cut (disconnecting the edge with max HS) and other well-known strategies as the higher betweenness centrality disconnection. All strategies were compared regarding the behavior of the robustness (R-index) during the attacks. In an attempt to simulate the internet backbone, the attacks were performed in complex networks with power-law degree distributions (scale-free networks). Preliminary results show that attacks based on disconnecting using the Hayastan Shakarian cut are more dangerous (decreasing the robustness) than the same attacks based on other centrality measures. We believe that the Hayastan Shakarian cut, as well as other measures based on the size of the largest connected component, provides a good addition to other robustness metrics for complex networks.
cs.SI
cs
The Hayastan Shakarian cut: measuring the impact of network disconnections Ivana Bachmann∗, Patricio Reyes†, Alonso Silva‡, Javier Bustos-Jim´enez∗ †Technological Institute for Industrial Mathematics (ITMATI), Santiago de Compostela, Spain. Email: [email protected] ∗NICLabs, Computer Science Department (DCC), Universidad de Chile. Emails: {ivana,jbustos}@niclabs.cl ‡Bell Labs, Alcatel-Lucent, Centre de Villarceaux, Nozay, France. Email: [email protected] 6 1 0 2 n a J 1 1 ] I S . s c [ 1 v 5 6 4 2 0 . 1 0 6 1 : v i X r a Abstract -- In this article we present the Hayastan Shakarian (HS), a robustness index for complex networks. HS measures the impact of a network disconnection (edge) while comparing the sizes of the remaining connected components. Strictly speaking, the Hayastan Shakarian index is defined as edge removal that produces the maximal inverse of the size of the largest connected component divided by the sum of the sizes of the remaining ones. We tested our index in attack strategies where the nodes are disconnected in decreasing order of a specified metric. We considered using the Hayastan Shakarian cut (disconnecting the edge with max HS) and other well-known strategies as the higher betweenness centrality disconnection. All strategies were compared regarding the behavior of the robustness (R-index) during the attacks. In an attempt to simulate the internet backbone, the attacks were performed in complex networks with power-law degree distributions (scale-free networks). Preliminary results show that attacks based on disconnecting using the Hayastan Shakarian cut are more dangerous (decreasing the robustness) than the same attacks based on other centrality measures. We believe that the Hayastan Shakarian cut, as well as other measures based on the size of the largest connected component, provides a good addition to other robustness metrics for complex networks. I. INTRODUCTION Networks are present in human life in multiple forms from social networks to communication networks (such as the Inter- net), and they have been widely studied as complex networks of nodes and relationships, describing their structure, relations, etc. Nowadays, studies go deep into network knowledge, and using standard network metrics such as degree distribution and diameter one can determine how robust and/or resilient a network is. Even though both terms (robustness and resilience) have been used with the same meaning, we will consider robustness as the network inner capacity to resist failures, and resilience as the ability of a network to resist and recover after such fail- ures. However, both terms have in common the methodology for testing robustness and/or resilience. Usually, they consist on planned attacks against nodes failures or disconnections, from a random set of failures to more elaborated strategies using well known network metrics. We consider that an "adversary" should plan a greedy strat- egy aiming to maximize damage with the minimum number of strikes. We present a new network impact metric called the Hayastan Shakarian index (HS), which reflects the size of the larger connected component after removing a network edge. Then, we plan a greedy strategy called the Hasyastan Shakarian cut (HSc), which is to remove the edge with higher HS value, aiming to partition the network in same-sized connected components, and recalculating the network HSs after each cut. We discuss the performance of attacks based on the Hayastan Shakarian cut and the edge betweenness centrality metric [3], compared by the robustness index (R- index). Our main conclusion is that the first strikes of the strategy the Hayastan Shakarian cut strategy causes more "damage" than the classical betweenness centrality metric in terms of network disconnection (R-index). The article is organized as follows, next section presents related work, followed by the definition of the Hayastan Shakarian cut, its attacking strategy, and its simulation results in Section III. Conclusions are presented in Section IV. II. RELATED WORK Over the last decade, there has been a huge interest in the analysis of complex networks and their connectivity prop- erties [2]. During the last years, networks and in particular social networks have gained significant popularity. An in- depth understanding of the graph structure is key to convert data into information. To do so, complex networks tools have emerged [1] to classify networks [21], detect communities [8], determine important features and measure them [3]. Concerning robustness metrics, betweenness centrality de- serves special attention. Betweenness centrality is a metric that determines the importance of an edge by looking at the paths between all of the pairs of remaining nodes. Betweenness has been studied as a resilience metric for the routing layer [16] and also as a robustness metric for complex networks [6] and for internet autonomous systems networks [9] among others. Betweenness centrality has been widely studied and standardized as a comparison base for robustness metrics, thus in this study it will be used for performance comparison. Another interesting edge-based metrics are: the increase of distances in a network caused by the deletion of vertices and edges [7]; the mean connectivity [19], that is, the probability that a network is disconnected by the random deletion of edges; the average connected distance (the average length of the shortest paths between connected pairs of nodes in the network) and the fragmentation (the decay of a network in component) with the other remaining sub-networks. HSN takes values between 0 (the whole network remains connected) to N − 1 (the whole network is disconnected). Then, we define that the Hayastan Shakarian cut as the one that disconnects the node with the highest HS-index value (when there is more than one, we choose it at random). That is: HSc = N \ e, where e = max(HSN (e)) ∀ e ∈ N (a) Original network (b) HS removing (c) BC removing Fig. 1. Effects of removing edges by (b) its maximal HS, and (c) its maximal betweenness centrality value. A. Network Attack Plan If we plan a network attack by disconnecting nodes with a given strategy (e.g. Figure 1), it is widely accepted to compare it against the use of betweenness centrality metric, because the latter reflects the importance of an edge in the network [6]. These attack strategies are compared by means of the Unique Robustness Measure (R-index) [14], defined as: N(cid:88) Q=1 terms of the size of its connected components after random edge disconnections) [2]; the balance-cut resilience, that is, the capacity of a minimum cut such that the two resulting vertex sets contain approximately the same number (similar to the HS-index but aiming to divide the network only in halves [20], not in equal sized connected components); the effective diameter ("the smallest h such that the number of pairs within a h-neighborhood is at least r times the total number of reachable pairs" [11]); and the Dynamic Network Robustness (DYNER) [15], where a backup path between nodes after a node disconnection and its length is used as a robustness metric in communication networks. The idea of planning a "network attack" using centrality measures has captured the attention of researchers and prac- titioners nowadays. For instance, Sterbenz et al. [17] used betweenness-centrality (bcen) for planning a network attack, calculating the bcen value for all nodes, ordering nodes from higher to lower bcen, and then attacking (discarding) those nodes in that order. They have shown that disconnecting only two of the top bcen-ranked nodes, their packet-delivery ratio is reduced to 60%, which corresponds to 20% more damage than other attacks such as random links or nodes disconnections, tracked by link-centrality and by node degrees. A similar approach and results were presented by C¸ etin- kaya et al. [4]. They show that after disconnecting only 10 nodes in a network of 100+ nodes the packet-delivery ratio is reduced to 0%. Another approach, presented as an improved network attack [12], [18], is to recalculate the betweenness- centrality after the removal of each node [5], [10]. They show a similar impact of non-recalculating strategies but discarding sometimes only half of the equivalent nodes. In the study of resilience after edge removing, Rosenkratz et al. [13] study backup communication paths for network services defining that a network is "k-edge-failure-resilient if no matter which subset of k or fewer edges fails, each resulting subnetwork is self-sufficient" given that "the edge resilience of a network is the largest integer k such that the network is k- edge-failure-resilient". For a better understanding of network attacks and strategies, see [5], [10], [12], [18]. III. THE HAYASTAN SHAKARIAN CUT Given a network N of size N, we denote by C(N \ e) the set of connected components in N after disconnecting edge e. The Hayastan Shakarian index (HS-index) for an edge e in N is defined as follows: (cid:80)  HSN (e) = (cid:107)c(cid:107) c∈C(N\e) maxc∈C(N\e)(cid:107)c(cid:107) − 1, if (cid:107)C(N \ e)(cid:107) (cid:54)= (cid:107)C(N )(cid:107) (1) R = 1 N s(Q), (2) 0 otherwise where (cid:107)c(cid:107), with c ∈ C(N \ e), is the size of the connected component c of the network N after disconnecting edge e. Notice that HSN (e) reflects the partition of a network in several sub-networks after the disconnection of edge e and how these sub-networks remain interconnected. Strictly speaking, it compares in size the core network (the largest connected where N is the number of nodes in the network and s(Q) is the fraction of nodes in the largest connected component after disconnecting (remove the edges among connected components) Q nodes using a given strategy. Therefore, the higher the R-index, the better in terms of robustness. Our strategy is: In each step, (re)compute the HS index for all the edges, and perform the Hayastan Shakarian cut. B. Simulations In an attempt to study the behavior of the internet back- bone, we test our strategy in simulated power-law degree distributions with exponents α ∈ {1.90, 2.00, 2.05, 2.10, 2.20} using Gephi. A power-law distribution is one that can be approximated by the function f (x) = k ∗ x−α, where k and α are constants. For each α, we simulate 50 networks of size 1000 (i.e., with 1000 nodes). Then, we tested and compared strategies ranked in terms of the R-index. Instead of just comparing the robustness, after the removal of all of the nodes, we studied the behavior of the attacks after only a few strikes. To do so, we define a variant of the R-index which takes into account only the first n strikes of an attack. Thus, for a simultaneous attack (where the nodes are ranked by a metric only once at the beginning), the Rn-index is defined as: n(cid:88) Q=1 Rn = 1 n s(Q). (3) For a sequential attack, the order of node disconnection is recomputed after each disconnection. Similar to the R-index, notice that the lower the Rn-index, the more effective the attack is, since that gives us a higher reduction of robustness. Results are shown in Figure 2. We tested sequential attacks: At each strike, the next node to disconnect was the one with the highest metric (whether it be HSc or betweenness centrality) in the current network. The figure shows the behavior of the Rn-index in 50 scale-free networks (generated as before) with exponent 1.9 to 2.2. The Hayastan Shakarian cut proves to be very effective in attacks with only a few disconnections. Moreover, it shows that the effectiveness persists over the number of strikes in scale-free networks with lower exponent. It is interesting to note that, no matter the metric used, the damage decreases in the long term with the number of strikes. Revisiting the definition of network robustness, that is, "a measure of the decrease of network functionality under a sinister attack"[5], it is important to notice that R-index is a metric for a general view of robustness, and it gives no information of how fast the network is disconnected. We suggest that weighted versions of the R-index could be a good compromise. This is the case of the Rn-index proposed above which takes into account the removal of only a percentage of the best ranked nodes (or until the network reaches its percolation threshold [5]) could be a more useful metric for robustness and/or resilience in worst-case scenarios. We start analyzing what would be the worst "attack". In the worst case, a "malicious adversary" will try to perform the maximum damage with the minimum number of strikes, that is, with the minimum number of node disconnections (made by the attacker). In terms of decreasing the size of the largest connected component, the Hayastan Shakarian cut is the best attack strategy during the first strikes. It achieves the disconnection of more than a quarter of the network only after 200 strikes for α = 2.10 and after 150 strikes for α = 2.05 (see Figure 2). It is important to notice that the greater the value of α the lower the number of strikes needed by the Hayastan Shakarian cut for reducing the original network to a connected component of 0.75 of the original size. C. Revisiting the Hayastan Shakarian cut Concerning the attacking strategies, it is important to notice that the Hayastan Shakarian cut was designed for disconnect- ing the network from the first strikes, aiming to get connected components with similar sizes. This is the main reason of its better performance compared to the betweenness centrality metric in a worst-attack scenario. For instance, in Figure 2 we present examples where the HS cut performs better attacks than an strategy using the betweenness centrality metric for different values of α. Notice that the Hayastan Shakarian cut performs better than the edge betweenness centrality strategy for values α < 2.1, disconnecting the former more than the half of the network in less strikes than the latter. Given that for a high coefficient (of the power law) the net- work would have a densely connected core with a few nodes, and many nodes of degree 1. In this case a Hayastan Shakarian cut will not be as effective as an edge betweenness attack since the HS-index of the nodes in the core is probably 0 (because is highly connected), performing a Hayastan Shakarian cut over those edges attached to nodes of degree 1. On the other hand, for a low coefficient (of the power law) the proportion of high degree nodes and low degree nodes is more similar than those of a high coefficient, this means the network is well connected even if it is not densely connected. In this case the Hayastan Shakarian cut will not cause that much damage (because the network is well connected) but it still causes more damage than edge betweenness, because edge betweenness chooses the edges with high traffic, and since the network is well connected it has many paths between any two nodes. Instead the Hayastan Shakarian cut will keep choosing the edges that causes more nodes to be disconnected. It is important Betweenness "generates" weak points by removing the edges with high traffic until there are no more alternative paths between 2 nodes. On the other hand the Hayastan Shakarian cut finds weak points that are already on the network (before removing a single edge, see Figure: 1). Therefore, the Hayas- tan Shakarian cut will not produce a network necessarily weaker, but a more fragmented and with stronger fragments. there is a breaking point where Hayastan Shakarian cut is no longer the best attacking strategy. As shown in Figure 2, this breaking point appears after the largest connected component is less than 1/4 of the original network. While an edge betweenness attack starts attacking the edges in the core with high traffic, this will not produce loss of nodes in the beginning but after a number of edge removals, making the network weak and vulnerable to the point where a single additional edge removal may greatly reduce the fractional size of the largest component, in our to notice that (a) α = 1.9 (b) α = 2.0 (c) α = 2.05 (d) α = 2.1 (e) α = 2.2 Fig. 2. cut (blue) and edge betweenness centrality (red). Size of the largest fractional connected component (Y-axis) vs. number of disconnected edges (X-axis) using as strategies the Hayastan Shakarian examples, of around 0.1. After the breaking point and for the same number of edges removed by the Hayastan Shakarian cut the fractional size of the largest component will be higher than the one produced by a edge betweenness attack. Another interesting property of HS-index occurs when max(HSN (e)) = 0. In other words, when the Hayastan Shakarian index is 0 for any node. In that case, the full network will remain connected no matter which edge is disconnected. Therefore, we suggest a resilience metric as the number (or percentage) of disconnected nodes until max(HSN (e)) > 0, a pre-defined threshold, or the percolation threshold [5]. IV. CONCLUSIONS AND FUTURE WORK In this article we have presented the Hayastan Shakarian cut (HSc), a robustness index for complex networks defined as the inverse of the size of the remaining largest connected component divided by the sum of the sizes of the remaining connected components. We tested our index as a measure to quantify the impact of node removal in terms of the network robustness metric R-index. We compared HSc with other attacks based on well- known centrality measures (betweenness centrality) for node removal selection. The attack strategy used was sequential targeted attack, where every index is recalculated after each removal, and the highest one is selected for the next extraction. Preliminary results show that the Hayastan Shakarian cut performs better compared to a betweenness centrality-based attack in terms of decreasing the network robustness in the worst-attack scenario (disconnecting more than the half of the network) for values of α < 2.1. We suggest that the Hayastan Shakarian cut, as well as other measures based on the size of the largest connected component, provides a good addition to other robustness metrics for complex networks. As future work, we can study improving through new connections an already existing network to make it more robust to attacks, and we can study networks in which the topological space is correlated with the cost of nodes disconnections, nodes which are nearby have a lower cost to be disconnected compared with nodes which are far apart. REFERENCES [1] R. Albert and A.-L. Barab´asi. Statistical mechanics of complex net- works. Reviews of Modern Physics, 74(1):47 -- 97, Jan. 2002. [2] R. Albert, H. Jeong, and A. Barabasi. Error and attack tolerance of complex networks. Nature, 406(6794):378 -- 82, July 2000. [3] N. I. Bersano-M´endez, S. E. Schaeffer, and J. Bustos-Jim´enez. Metrics In Computational Social Networks, and models for social networks. pages 115 -- 142. Springer, 2012. [4] E. K. C¸ etinkaya, D. Broyles, A. Dandekar, S. Srinivasan, and J. P. Sterbenz. Modelling communication network challenges for future internet resilience, survivability, and disruption tolerance: A simulation- based approach. Telecommunication Systems, 52(2):751 -- 766, 2013. [5] P. Holme, B. J. Kim, C. N. Yoon, and S. K. Han. Attack vulnerability of complex networks. Physical Review E, 65(5):056109, 2002. [6] S. Iyer, T. Killingback, B. Sundaram, and Z. Wang. Attack robustness and centrality of complex networks. PloS one, 8(4):e59613, 2013. [7] V. Krishnamoorthy, K. Thulasiraman, and M. Swamy. Incremental distance and diameter sequences of a graph: new measures of network performance. Computers, IEEE Transactions on, 39(2):230 -- 237, 1990. [8] J. Leskovec, K. J. Lang, A. Dasgupta, and M. W. Mahoney. Statistical properties of community structure in large social and information networks. Proceeding of the 17th international conference on World Wide Web - WWW '08, page 695, 2008. [9] P. Mahadevan, D. Krioukov, M. Fomenkov, X. Dimitropoulos, A. Vah- dat, et al. The internet as-level topology: three data sources and one definitive metric. ACM SIGCOMM Computer Communication Review, 36(1):17 -- 26, 2006. [10] W. Molisz and J. Rak. End-to-end service survivability under attacks on networks. Journal of Telecommunications and Information Technology, pages 19 -- 26, 2006. [11] C. R. Palmer, G. Siganos, M. Faloutsos, and C. Faloutsos. The connectivity and fault-tolerance of the internet topology. In Workshop on Network-Related Data Management (NRDM 2001), In cooperation with ACM SIGMOD/PODS, 2001. [12] J. Rak and K. Walkowiak. Survivability of anycast and unicast flows under attacks on networks. In Ultra Modern Telecommunications and Control Systems and Workshops (ICUMT), 2010 International Congress on, pages 497 -- 503. IEEE, 2010. [13] D. J. Rosenkrantz, S. Goel, S. Ravi, and J. Gangolly. Resilience metrics for service-oriented networks: A service allocation approach. Services Computing, IEEE Transactions on, 2(3):183 -- 196, 2009. [14] C. M. Schneider, A. A. Moreira, J. S. Andrade, S. Havlin, and H. J. Herrmann. Mitigation of malicious attacks on networks. Proceedings of the National Academy of Sciences, 108(10):3838 -- 3841, 2011. [15] Y. Singer. Dynamic measure of network robustness. In Electrical and electronics engineers in israel, 2006 ieee 24th convention of, pages 366 -- 370. IEEE, 2006. [16] P. Smith, D. Hutchison, J. P. Sterbenz, M. Scholler, A. Fessi, M. Kar- aliopoulos, C. Lac, and B. Plattner. Network resilience: a systematic approach. Communications Magazine, IEEE, 49(7):88 -- 97, 2011. [17] J. P. Sterbenz, E. K. Cetinkaya, M. Hameed, A. Jabbar, J. P. Rohrer, et al. Modelling and analysis of network resilience. In Communication Sys- tems and Networks (COMSNETS), 2011 Third International Conference on, pages 1 -- 10. IEEE, 2011. [18] A. Sydney, C. Scoglio, M. Youssef, and P. Schumm. Characterising the robustness of complex networks. International Journal of Internet Technology and Secured Transactions, 2(3-4):291 -- 320, 2010. [19] M. Tainiter. Statistical theory of connectivity i: Basic definitions and properties. Discrete Mathematics, 13(4):391 -- 398, 1975. [20] H. Tangmunarunkit, R. Govindan, S. Jamin, S. Shenker, and W. Will- inger. Network topology generators: Degree-based vs. structural. ACM SIGCOMM Computer Communication Review, 32(4):147 -- 159, 2002. [21] D. J. Watts and S. H. Strogatz. Collective dynamics of 'small-world' networks. Nature, 393(6684):440 -- 2, June 1998.
1909.08189
1
1909
2019-09-17T15:00:14
Two Computational Models for Analyzing Political Attention in Social Media
[ "cs.SI", "cs.LG", "stat.ML" ]
Understanding how political attention is divided and over what subjects is crucial for research on areas such as agenda setting, framing, and political rhetoric. Existing methods for measuring attention, such as manual labeling according to established codebooks, are expensive and can be restrictive. We describe two computational models that automatically distinguish topics in politicians' social media content. Our models---one supervised classifier and one unsupervised topic model---provide different benefits. The supervised classifier reduces the labor required to classify content according to pre-determined topic list. However, tweets do more than communicate policy positions. Our unsupervised model uncovers both political topics and other Twitter uses (e.g., constituent service). These models are effective, inexpensive computational tools for political communication and social media research. We demonstrate their utility and discuss the different analyses they afford by applying both models to the tweets posted by members of the 115th U.S. Congress.
cs.SI
cs
Two Computational Models for Analyzing Political Attention in Social Media Libby Hemphill, Angela M. Schopke-Gonzalez School of Information University of Michigan Ann Arbor, MI 48104 {libbyh, aschopke}@umich.edu 9 1 0 2 p e S 7 1 ] I S . s c [ 1 v 9 8 1 8 0 . 9 0 9 1 : v i X r a Accepted for publication in the International AAAI Conference on Web and Social Media (ICWSM 2020) Abstract Understanding how political attention is divided and over what subjects is crucial for research on areas such as agenda setting, framing, and political rhetoric. Existing methods for measuring attention, such as manual labeling according to established codebooks, are expensive and can be restric- tive. We describe two computational models that automati- cally distinguish topics in politicians' social media content. Our models -- one supervised classifier and one unsupervised topic model -- provide different benefits. The supervised clas- sifier reduces the labor required to classify content accord- ing to pre-determined topic list. However, tweets do more than communicate policy positions. Our unsupervised model uncovers both political topics and other Twitter uses (e.g., constituent service). These models are effective, inexpensive computational tools for political communication and social media research. We demonstrate their utility and discuss the different analyses they afford by applying both models to the tweets posted by members of the 115th U.S. Congress. Questions about which political topics receive attention and how that attention is distributed are central to issues such as agenda setting and framing. Knowing what politicians are talking about and how those topics differ among vari- ous populations (e.g., Democrats and Republicans) and over time could enable advances in political communication re- search and has potential to increase constituents' knowledge. As social media becomes an increasingly common site of political discussion and impact, it becomes possible to ex- ploit the data social media generates to understand political attention (Barber´a et al., 2018; Neuman et al., 2014). Twit- ter activity, especially, relates to media and elites' political attention (Shapiro and Hemphill, 2017; Guggenheim et al., 2015; Rill et al., 2014) and offers an opportunity to measure attention and its changes over time. We use data from Twitter to address two primary chal- lenges in studying political attention and congressional com- munication. First, existing methods for studying political at- tention, such as manual topic labeling, are expensive and restrictive. Second, our methodological tools for studying Copyright c(cid:13) 2019, Association for the Advancement of Artificial Intelligence (www.aaai.org). All rights reserved. Congress on Twitter have not kept pace with Congress's adoption and use. To address these challenges, we developed two compu- tational models for estimating political attention -- one su- pervised model that leverages human labels to classify texts at scale and a second unsupervised model that uses readily- available data and low computational overhead to automat- ically classify social media posts according to their policy topic and communication style. By providing the models and their codebooks, we enable others to label political texts efficiently and automatically. This facilitates efficient and nuanced studies of Congress's political attention and com- munication style and supports comparative studies of politi- cal attention across media (i.e., social media, congressional hearings, news media). We demonstrate the utility of these approaches by applying the models to the complete corpus of tweets posted by the 115th U.S. Congress and briefly dis- cussing the insights gained. We also discuss the costs and benefits of supervised and unsupervised models and provide aspects of each to consider when choosing a tool for analy- sis. In summary, our contributions are 1. a supervised model for assigning tweets to a pre-existing set of policy topics and facilitating comparative analyses; 2. an unsupervised model for assigning tweets to inferred policy topics and communication uses; and 3. trade offs to consider when choosing supervised and/or unsupervised approaches to topic labeling. Labeling content by hand requires tremendous human ef- fort and substantial domain knowledge (Quinn et al., 2010). Attempts to crowd source annotation of political texts ac- knowledge that domain expertise is required for classifying content according to existing policy code books (Benoit et al., 2016; Haselmayer and Jenny, 2017; Lehmann and Zo- bel, 2018). Using pre-defined codebooks assumes a particu- lar set of topics and therefore cannot effectively classify con- tent that falls outside those predefined areas; however, code- books enable comparisons across governing bodies, over time, and among groups. Quinn and colleagues (2010) pro- vide a more detailed overview of the challenges associ- ated with labeling according to known topics and by hand; they also provide a topic-modeling approach to classifying speech in the Congressional Record that is similar to ours. Our approach differs from Quinn et al.'s in the types of documents we use for the model (speeches from the Con- gressional Record vs tweets) and the model's assumptions. They employ a dynamic model that includes time parame- ters that distinguish days in session from days not in session, and our approach uses a static latent Dirichlet model (LDA) similar to Barber´a et al.'s (2018; 2014). The static model is appropriate in our case because tweets do not exhibit the time parameters of Congressional speeches (i.e., speeches at time t and t + 1 are likely related while the same is not nec- essarily true for tweets). Our approach differs from Barber´a et al.'s in that we use individual tweets rather than aggre- gates by day, party, and chamber. Despite earlier work that suggests tweets are too short for good topic models (Hong and Davison, 2010), we found acceptable performance and useful sensitivity by using individual tweets (see Zhao et al., 2011). Congress increasingly uses social media as a mechanism for speaking about and engaging with constituencies (Straus et al., 2013), but our tools for studying their social me- dia use have not kept pace. Existing studies of members of Congress's (MCs') social media use rely on the human la- beling and domain knowledge mentioned above (Russell, 2017, 2018; Evans, Cordova, and Sipole, 2014; Frechette and Ancu, 2017) or focus on the frequency (LaMarre and Suzuki-Lambrecht, 2013) or type of use (Golbeck et al., 2018; Hemphill, Otterbacher, and Shapiro, 2013) rather than the content of messages. MCs' social media speech can be used for understanding polarization (Hemphill, Culotta, and Heston, 2016; Hong and Kim, 2016) and likely impacts po- litical news coverage (Shapiro and Hemphill, 2017; Moon and Hadley, 2014), and new methodological tools for es- timating attention and style would provide richer views of activity and enable new analyses. Why Twitter Existing work in political attention relies largely on political speeches (Laver, Benoit, and Garry, 2003; Oliver and Rahn, 2016; Yu, Kaufmann, and Dier- meier, 2008; Quinn et al., 2010) and party manifestos (Gabel and Huber, 2000; Slapin and Proksch, 2008; Benoit et al., 2016). At the same time, politicians around the world in- creasingly use social media to communicate, and researchers are examining the impacts of that use on elections (Bossetta, 2018; Karlsen, 2011), the press (Murthy, 2015; Shapiro and Hemphill, 2017), and public opinion (Michael and Agur, 2018). Given its prevalence among politicians and in the public conversation about politics, politicians' behavior on Twitter deserves our attention. We also expect that Twitter data's availability and frequent updating will enable us to study political attention more efficiently and at a larger scale than prior data sources. In order to understand how U.S. Congressional tweets may help us to answer social and political research ques- tions (e.g., How does MC attention change over time? Does social media influence the political agenda? Does Congress respond to the public's policy priorities?), we must first un- derstand what U.S. MCs are saying. Given the volume of content that MCs generate and the expertise required to clas- sify it, manual labeling is neither efficient nor affordable in Senate House Dem GOP Dem GOP 207 24 231 128 64 192 48 5 53 32 16 48 Total 415 109 524 Men Women Total Table 1: Number of accounts by party, chamber, and gender. Two independent senators who caucus with Democrats have been grouped with them. Senate Dem 143,522 74,905 218,427 GOP 171,083 19,867 190,950 Men Women Total House Dem 441,890 212,457 654,347 GOP 356,870 65,240 422,110 Table 2: Number of tweets by party, chamber, and gen- der. Two independent senators who caucus with Democrats have been grouped with them. Cell values are the count of tweets posted by the intersection of the row and column. Men posted 1,113,365 tweets, and women posted 372,469. the long term. We therefore explore whether computational labeling approaches could help us understand MC conversa- tions on Twitter. Computational study of MCs use of Twitter will eventu- ally allow us to (1) situate the MCs' political attention pat- terns on Twitter within the broader media context, (2) under- stand whether MCs' political attention patterns on Twitter reflect attention patterns in a broader media context, and (3) understand the unique value that the use of supervised clas- sification and unsupervised topic modeling techniques can contribute to our overall understanding of MCs' political at- tention patterns. Data Tweets from the 115th U.S. Congress Using the Twitter Search API, we collected all tweets posted by official MC accounts (voting members only) during the 115th U.S. Congress which ran January 3, 2017 to January 3, 2019. We identified MCs' Twitter user names by combin- ing the lists of MC social media accounts from the United States project1, George Washington Libraries2, and the Sun- light Foundation3. Throughout 2017 and 2018, we used the Twitter API to search for the user names in this composite list and retrieved the accounts' most recent tweets. Our final search occurred on January 3, 2019, shortly after the 115th U.S. Congress ended. In all, we collected 1,485,834 original tweets (i.e., we excluded retweets) from 524 accounts. The accounts differ 1https://github.com/unitedstates/congress- legislators 2https://dataverse.harvard.edu/dataset. xhtml?persistentId=doi:10.7910/DVN/UIVHQR 3https://sunlightlabs.github.io/congress/ index.html#legislator-spreadsheet 2 from the total size of Congress because we included tweet data for MCs who resigned (e.g., Ryan Zinke) and those who joined off cycle (e.g., Rep. Conor Lamb); we were also unable to confirm accounts for every state and district. We summarize the accounts by party, chamber and gender in Ta- ble 1 and the number of tweets posted by chamber, gender, and party in Table 2. Two Models for Classifying Tweets According to Political Topics Preprocessing We used the same preprocessing steps for both the super- vised and unsupervised models: Stemming We evaluated whether or not to use stem- ming or lemmatization in training our models by reviewing the relative interpretability of topics generated by models trained with each of stemmed texts and unstemmed texts. We found unstemmed texts render significantly more inter- pretable generated topics, likely reflecting syntactical asso- ciations with semantic meanings, which is consistent with prior work (Schofield and Mimno, 2016). This pattern is likely especially relevant for tweet data given that unique linguistic patterns and intentional misspellings are used to communicate different semantic meanings. Stemming in these instances may remove the nuance in potential seman- tic meaning achieved by tweets' unique linguistic features including misspellings. Therefore, we did not use stemming or lemmatization in data preprocessing for the final models. Stop lists, tokenization, and n-grams Given the preva- lence of both English- and Spanish-language tweets, this project removed both English and Spanish stop words in- cluded in Python's Natural Language Toolkit (NLTK) de- fault stop word lists (Bird, Klein, and Loper, 2009). We also used a combination of two tokenization ap- proaches to prepare our data for modeling. First, we used Python's NLTK tweetTokenizer with parameters set to ren- der all text lower case, strip Twitter user name handles, and replace repeated character sequences of length three or greater with sequences of length three (i.e. "Heeeeeeeey" and "Heeeey" both become "Heeey"). Second, we removed punctuation (including emojis), URLs, words smaller than two letters, and words that contain numbers. In the early stages of model development, we evaluated the comparative intepretability and relevance of topics gen- erated for document sets tokenized into unigrams, bigrams, and a combination of unigrams and bigrams. We found model results for document sets tokenized into unigrams to be most interpretable and relevant, and thus present only these results here. Specifying Models Document Selection We used the same documents for each model: individual, original tweets. We compared the coherence and interpretability of models using other docu- ment types (e.g., author-day, author-week, and author-month aggregations in alignment with Quinn et al. (2010) and Bar- ber et al.'s (2018) findings that aggregations improve model 3 performance) and found models using individual tweets to produce interpretable, facially valid topics. We expect that the individual tweet approach works well because individuals are discussing more multiple topics per day. Congressional speeches, like those Quinn et al. use, are likely more constrained than tweets over short periods, and therefore are appropriate to aggregate. Aggregations over long periods such as author-week and author-month docu- ments produced even less distinct topics. Model Output Both models produce the same type of out- put. The models determine the probability that a given tweet belongs in each of the topics (categories for the supervised model and inferred topics for the unsupervised) and then as- signs the highest-probability category. We also report the second-most likely category assigned by the unsupervised model in cases where mutually exclusive categories are not required or where a second class provides additional infor- mation about the style or goal of the tweets. These out- puts mean that the supervised model's predictions are di- rectly aligned with the CAP codebook, and the unsupervised model's predictions capitalize on its ability to relax require- ments and to discover multiple topics and features within tweets. Supervised Classifier We trained a supervised machine learning classifier using labeled tweets from Russell's re- search on the Senate (2017; 2018). The dataset contains 68,398 tweets total: 45,402 tweets labeled with codes from the Comparative Agenda Project's (CAP's) codebook (Be- van, 2017) and 22,996 labeled as not-policy tweets. The CAP codebook is commonly used in social, political, and communication science to understand topics in different types of political discourse worldwide (see, e.g., Baum- gartner, 2019; Baumgartner and Jones, 1993; John, 2006, for the project's introduction and recent collections of re- search) and to evaluate unsupervised topic modeling ap- proaches (Quinn et al., 2010; Barber´a et al., 2018). Recent discussions of the CAP codebook center around its mutu- ally exhaustive categories and backward compatibility when discussing its use as a measurement tool in political atten- tion research (Jones, 2016; Dowding, Hindmoor, and Mar- tin, 2016). We removed retweets to limit our classification to original tweets, resulting in a total set of 59,826 labeled tweets (39,704 policy tweets and 20,122 not policy tweets). The training set was imbalanced, and we found using a sub- set of the over-represented not-policy tweets in training im- proved the model's performance. Our final training corpus included 41,716 tweets (39,704 policy tweets and 2,012 not policy tweets). We trained and tested four types of supervised classifica- tion models using NLTK (Bird, Klein, and Loper, 2009) im- plementations: a random guessing baseline dummy model (D) using stratified samples that respect the training data's class distribution, a Naıve Bayes (NB) model, a Logistic Re- gression (LR) model, and a Support Vector Machine (SVM) model. In each case, we used a 90-10 split for train-test data meaning that 90% of labeled tweets were used as training in- stances, and the models then predicted labels for the remain- ing 10%. After initial testing, for each of our top-performing models (LR and SVM), we evaluated whether the addition of Word2Vec (W2V; Mikolov et al., 2013) word embedding features or Linguistic Inquiry and Word Count (LIWC; Pen- nebaker, Booth, and Francis, 2015) features could improve their performance. We extracted all LIWC 2015 features for each token in our Tweet token corpus and integrated them as features into our model. In all cases, we used a 90/10 split for training/test data. Unsupervised Topic Model We present the results of the unsupervised model generated using MALLET's LDA model wrapper ( Rehurek and Sojka, 2010). We tested other models (described in more detail below) but found the MAL- LET LDA wrapper produced the most analytically useful (i.e., interpretable, relevant) topics. The MALLET LDA wrapper requires that we specify a number of topics to find in advance. We evaluated the performance of models gener- ating between 5 and 70 topics in increments of five topics within this range. We found 50 topics to yield the most in- terpretable, relevant, and distinct results. We found that the results of the gensim LDA model were insufficiently interpretable to provide analytic utility. We also considered Moody's lda2vec (2016), and though pre- liminary results did return more nuanced topics, we found its setup and computational inefficiency to be too cum- bersome and costly relative to the benefit of that nuance. LDA models are a popular and effective choice in recent topic modeling work, though much of that work uses su- pervised approaches (McAuliffe and Blei, 2008; Nguyen, Ying, and Resnik, 2013; Resnik et al., 2015; Perotte et al., 2011). Therefore, we considered Supervised LDA (sLDA McAuliffe and Blei, 2008) as a third alternative approach, but found it even less computationally efficient than lda2vec. Though they often demonstrate improved performance over LDA models, we did not use Structural Topic Modeling (STM) techniques (Roberts et al., 2014) because of their as- sumptions about the relationships between metadata (e.g., party affiliation) and behavior are actually the objects of study in our use case -- we cannot study party differences if we include party in the model's specifications. Evaluating Models We summarize the performance of our supervised mod- els in Table 3; the models performed quite similarly despite variations in their algorithms and features. Our highest-performing supervised classifier (logistic regres- sion) achieved an F1 score of 0.79. The F1 score balances the precision and recall of the classifier to provide a mea- sure of performance. Given the difference between our clas- sifier's score and the dummy, we argue the supervised clas- sifier achieved reasonable accuracy. We used an inductive approach to interpret and label topics returned by our final unsupervised model. We first labeled the baseline model's topics according to our ini- tial interpretations, allowing us to discover semantically- important topics that arise from the data rather than from a predetermined topic set. Human interpretation and label assignment was performed by two domain experts and con- firmed by a third. One expert has prior experience on leg- islative staff having served in a senior senator's office and in public affairs for political organizations. She was able to de- termine whether the topics identified by the classifier were interpretable and were actually capturing political topics as members of Congress understand them. The second expert has spent 12 years working in political communication re- search, allowing her to understand topics returned within the context of political behavior. The two labelers discussed disagreements until both agreed on the labels applied to all fifty topics. Following this first labeling process, we looked for patterns across labels and grouped labels together that indicated topical similarity based on their highest-weighted features. For instance, one topic's top unigram features in- cluded health, care, Americans, Trumpcare and another in- cluded health, care, access, women. We bundled both of these topics under the umbrella healthcare. Finally, we re- viewed our topic labels and features with a senior member of a U.S. policy think tank to confirm the validity of our la- bels and interpretability of our topics. Classifier D NB LR LR + pre-trained w2v features LR + original w2v features LR + LIWC SVM SVM + pre-trained w2v features SVM + original w2v features SVM + LIWC F1 0.07 0.71 0.79 0.77 0.78 0.78 0.78 0.77 0.78 0.77 Prec. Recall 0.07 0.74 0.79 0.78 0.79 0.78 0.79 0.78 0.79 0.78 0.07 0.72 0.79 0.77 0.78 0.78 0.78 0.77 0.77 0.77 Table 3: Supervised Classifier Performance Summary: dummy (D), Naıve Bayes (NB), Logistic Regression (LR) model, and Support Vector Machine (SVM) models are in- cluded. Features included unigrams, word vectors (w2v) and LIWC features Where possible, we matched CAP codes to the related codes that resulted from our inductive labeling. A complete list of our topics, their associated CAP codes, and their fre- quencies is available in Table 4.4 Not all of our codes had ready analogues in the CAP taxonomy. For instance, our un- supervised model identified media appearance as a separate and frequent topic. The CAP codebook includes only policy areas and not relationship-building or constituent service ac- tivities, and so no CAP label directly applied there. Further, we determined that some nuanced aspects of the topics re- turned by our unsupervised model are not captured by the policy focus of the CAP codebook. For example, our unsu- pervised model returned several topics clearly interpretable as related to veteran affairs. The CAP codebook includes as- pects of veteran affairs as a sub-topic under both housing and defense, but given that our unsupervised model detected veteran-related issues outside of these sup-topic areas, we 4The CAP codebook does not include codes 11 or 22. 4 Topic Description macroeconomics civil rights health agriculture labor education environment energy immigration transportation law and crime social welfare housing domestic commerce defense technology foreign trade international affairs government operations public lands cultural affairs veterans sports district affairs holidays awards politicking self promotion sympathy emergency response legislative process constituent relations power relations uninterpretable # 1 2 3 4 5 6 7 8 9 10 12 13 14 15 16 17 18 19 20 21 23 24 25 26 27 28 29 30 31 32 33 34 35 - SU 0.060 0.037 0.088 0.010 0.022 0.021 0.018 0.013 0.021 0.011 0.043 0.009 0.003 0.027 0.066 0.006 0.002 0.027 0.037 0.009 - - - - - - - - - - - - - - UN1 0.074 0.094 0.318 0.019 0.021 0.021 0.045 - 0.017 - 0.026 0.020 - 0.023 - - - - 0.072 - - 0.019 0.020 0.071 0.009 - - 0.050 - 0.018 - - 0.026 0.037 UN2 0.042 0.040 0.043 0.014 0.016 0.016 0.012 - 0.012 0.020 0.018 0.014 - 0.018 0.019 0.005 - - 0.059 0.010 - 0.026 0.011 0.063 0.027 0.009 0.042 0.052 0.010 0.013 0.059 0.022 0.024 0.284 Table 4: Topic Distribution Across the 115th U.S. Congress. Contains proportional distributions across all topics for both supervised (SU) and unsupervised (UN1 and UN2) clas- sifiers. UN1 indicates the highest probability category as- signed, and UN2 indicates the second highest. Topics 1-23 correspond to labels in the CAP codebook, and 24-35 are new codes identified by our unsupervised model. determined that a new high-level topic devoted solely to vet- eran affairs would better describe the thematic content of those topics. A similar situation applied to the topic we la- beled legislative process, some but not all aspects of which may have fallen under CAP code government operations. The codes we identified that were not captured by the CAP codebook are marked by "-" in the Code Number column of Table 4. Topic Coherence Topic coherence -- numerical evaluation of how a "fact set can be interpreted in a context that cov- ers all or most of the facts" present in the set (Roder, Both, and Hinneburg, 2015) -- was one consideration when decid- 5 ing whether we had found the right number and mix of topics using the unsupervised classifier. Recent work has sought to quantitatively evaluate topic model performance using mea- sures such as perplexity (Barber´a et al., 2018). However, perplexity actually correlates negatively with human inter- pretability (Chang et al., 2009). As an alternative to perplex- ity, Lau et al. (2014; 2016) and Fang et al. (2016) provide topic coherence evaluation measures that use point wise mu- tual information (NPMI and PMI) and find them to emulate human interpretability well. Given this existing research, we implemented the NPMI topic coherence measure (Lau, Newman, and Baldwin, 2014; Lau and Baldwin, 2016) to evaluate early iterations of our topic models. Reference corpus selection is an especially important component of ensuring that the NPMI topic coher- ence metric provides a useful measure by which to evaluate a topic models performance. We tested two reference cor- pora: a set of random tweets and all U.S. legislative bill text from the 115th U.S. Congress. Initial results yielded very low topic coherence values across both reference corpora in relation to those topic co- herence measures reported elsewhere (Lau, Newman, and Baldwin, 2014). This discrepancy likely indicates that ran- dom tweets are insufficiently specific and that bill text is too syntactically dissimilar from MC tweets for either corpus to be an appropriate reference text. Therefore, for final model iterations we evaluate our models solely according to human interpretability. Comparing Models' Output The supervised model provides a single topic label for each tweet, and the unsupervised model provides probabilities for each tweet-class pair. In order to compare the labels between classifiers, we assigned tweets the highest-probability topic indicated by the unsupervised model. We measured interan- notator agreement between our supervised and unsupervised models using Cohen's kappa (McHugh, 2012). We opted to use Cohen's kappa as a measure that is widely-used for comparing two annotators (Hellgren, 2012). Because our su- pervised model assigns topic labels only to policy-related tweets, a comparison between supervised and unsupervised models is only meaningful for those tweets both models la- beled, or policy-related tweets. Therefore, we calculated a Cohen's kappa score between our supervised and unsuper- vised model for only policy-related tweets with label assign- ments corresponding to CAP codes. The two classifiers achieved a Cohen's kappa of 0.262. We argue that the classifiers likely measure different things, and the low agreement suggests an opportunity for re- searchers to select the tool that matches their analytic goals. Low agreement suggests that the two models are well- differentiated; we return to this discussion in detail below. The features associated with each models' classes are pre- sented in tables 5 and 6 and also indicate that the models are distinct. Label macroeconomics civil rights health agriculture labor education environment energy immigration transportation law and crime social welfare housing domestic commerce defense technology foreign trade international affairs government operations public lands fiscalcliff energyinde- Associated Terms budgetconference budgetdeal passenda enda nsa defundobamacare obamacare healthcare farmbill gmo sugar fmla minimumwage laborday talkhighered dontdouble- myrate studentloans actonclimate leahysummit cli- mate energyefficiency pendence immigrationreform immigra- tion cirmarkup skagitbridge lays faa vawa guncontrol gunviolence snap nutrition hungry gsereform fha housing fema sandyrelief sandy veteransday drones stolenvalor marketplacefairness nonettax broadband trade exports export benghazi standwithisrael nomination irs nominations commissiononnativechildren tribalnations obamaflightde- Table 5: Features Associated with Topics in the Supervised Classifier Applying Models to 115th U.S. Congress's Tweets We applied both the supervised and unsupervised models to all of the original tweets posted by the 115th U.S. Congress and use those results to illustrate the analytic potential of these new methodological tools. Topic Distribution In Table 4, each of topics 1-23 corre- spond to the CAP macro-level code numbers. Topic 23, cul- tural affairs was not detected by either of our models, and as such receives a "-" value across all columns. Each topic 24-35 corresponds to expert interpretations of unsupervised topic model results; we assigned "0" to tweets whose top- ics were uninterpretable by either model. Since these latter topics apply only to the unsupervised model's results, each of these topics receives a "-" value in column "SU". Re- lated, each of topics energy, housing, foreign trade, and in- ternational affairs received "-" values in column "UN1"). These "-" values indicate that our unsupervised model did not detect topics that human interpretation would assign one of these four CAP codebook topics. Label macroeconomics civil rights health agriculture labor education environment immigration transportation law and crime social welfare domestic commerce defense technology government operations public lands veterans sports district affairs holidays awards politicking self promotion sympathy emergency response legislative process constituent relations power relations Associated Terms budget government house bill; tax families cuts; tax jobs re- form trump president american to- day life rights women rights equal health care americans; opioid help health; health getcovered enrollment energy jobs farmers obamacare jobs year students education student climate change water children border families will infrastructure funding sexual human trafficking; gun violence congress families workers care small jobs businesses iran nuclear security internet netneutrality open act bill protect; court senate; russia; obama rule president national protect public veterans service honor; women service men game team win office help hours; today great new; service academy fair; hall town meeting day happy today; family will friend; happy year celebrating school congressional art make work keep; forward work working read week facebook; tune watch live; hearing watch committee families victims prayers help disaster hurricane bill house act; today discuss is- sues; vote voting voter work community thank today president mayor judge investigation trump Table 6: Features Associated with Topics in the Unsuper- vised Model. Longer feature lists indicate that multiple un- supervised topics were merged into a single parent topic. Discussion Examining the output from the two models on the same dataset, tweets from the 115th U.S. Congress, helps explain the models' differences, trade-offs, and clarifies the new in- sights available from the unsupervised model. 6 (a) (b) (c) Figure 1: Topic Distributions. (a) shows the overall topic distribution according to the supervised classifier. (b) contains a 100% stacked bar chart indicating the proportion of tweets of that type that came from Republicans (red) and Democrats (blue) as labeled by the supervised classifier. (c) shows the proportion of tweets of that type that came from Republicans (red) and Democrats (blue) as indicated by the second-highest topic according to the unsupervised classifier. Comparing Model Labels First, we examined the proportion of supervised labels matching most likely unsupervised labels for policy-related tweets. Table 4 shows that both models were able to de- tect a topic in nearly all tweets (i.e., the proportion of un- interpretable appears relatively infrequently). The uninter- pretable topic's features were comprised largely of prepo- sitions, conjunctions, and other words with little seman- tic meaning. This suggests that the most significant seman- tic meaning of a tweet labeled by the unsupervised model can likely be understood by using its maximum probability topic. In Figure 1 (a), we include the supervised model and most-likely topic from the unsupervised model because those two topics are policy-related. In Figure 1 (b) and (c), we report the supervised classifier label and second-most likely unsupervised topic label to illustrate how it's pos- sible to use each classifier for different analytic purposes. The supervised classifier, Figure 1 (b), shows us differences in political attention by party. The unsupervised classifier's second-most likely, see Figure 1 (c), category enables us to compare the style by party. We can see that Republicans give less attention to civil rights, environment, and social welfare and more attention to energy and defense than Democrats. None of these differences are especially surprising given the parties' priorities, but our models show empirically that the differences are observable even in social media. Among the unsupervised model's style codes, Republicans exhibit more self promotion than Democrats, but the parties are nearly equal on those style codes. Our model affords similar com- 7 Additional similarities and differences in the proportions of SU and UN2 in Figure 1 may help us to understand the utility of each model. We can see that our unsupervised model's maximum probability topic predictions did not in- clude topic labels transportation, defense, technology, pub- lic lands for any policy-related tweets. However, we can also see that each of these topics are included among the unsuper- vised model's second most probable topic predictions. This suggests that in some policy topics' cases, each of our su- pervised and unsupervised models may be able to predict approximately similar ideas if both most probable and sec- ond most probable topics are taken into account. Interestingly, we see that the government operations topic is predicted with about the same frequency by the super- vised model and each of the unsupervised model's first most probable topic assignment and second most probable topic assignment. This again suggests that the unsupervised model and supervised model both are able to predict approximately similar ideas. parisons among other groups such as gender or chamber that may provide insight into how political attention changes or how communication styles differ among groups. In general, we notice that among the second-most prob- able topics for the unsupervised model, topics 24-35, or all those topics that are not featured in the CAP codebook, oc- cur more frequently. This suggests that the topic of high- est probability more effectively captures a policy focus, and the topic of second-highest probability captures the way in which, the reason for, and with whom MCs are discussing these policy issues. Rare Topics The unsupervised model did not detect the following CAP codebook topics: energy, housing, foreign trade, interna- tional affairs. This likely indicates that these topics are oc- curring rarely enough that the unsupervised model does not have enough data to detect these topics as distinct from oth- ers. In reviewing Figure 1, it is possible to see that a very low proportion of tweets were labeled housing or foreign trade by the supervised classifier, for example. That these topics are not frequently occurring according to the super- vised model either suggests that that MCs do not spend a lot of time tweeting about those topics. These omissions are likely an artifact of the U.S. federal government's structure. Though housing, for example, is in part an issue addressed by the U.S. Department of Housing and Urban Development and thus an appropriations issue for the U.S. Congress, many housing issues are addressed at state and local levels. It is possible that given this distribution of significant responsi- bility to the state and local levels, MCs spend less time talk- ing about housing at the federal level. Where the Models Diverge It is also possible that those terms associated with these top- ics for the supervised model are being associated with or grouped together with terms corresponding to different top- ics. For example, given that international affairs, defense, and immigration topic areas have some overlapping topi- cal relevance, it is possible that certain tweets were labeled by the unsupervised classifier as defense or immigration rather than international affairs as by the supervised clas- sifier. By examining the features associated with each topic in each classifier (see Tables 5 and 6), we can see some of these differences. For instance, the defense topic has features "iran", "nuclear", and "strategy" in the unsupervised model and "veteransday", "drones", and "stolenvalor" in the super- vised model. In the unsupervised model, topics about vet- erans emerged that were distinct from defense and housing, where veterans occur in the CAP codebook. So we see that similar terms are associated with different topics in the two types of models, and that explains some of their differences. However, each set of associations is reasonable and inter- pretable, and that suggests that the models capture different latent properties with their feature-class associations. Remember that the resulting Cohen's kappa between su- pervised and unsupervised model results was only 0.262. Common practice suggests that a Cohen's kappa of .21- .40 indicates fair interannotator agreement, with 0 indicating interannotator agreement that approximates random choice (McHugh, 2012). In this sense 0.262 does not represent par- ticularly high interannotator agreement between the super- vised and unsupervised models. In order to understand why this was, we examined individual cases of disagreement and agreement. We discuss example cases below, how these dis- agreements contribute to the Cohen's kappa score returned, and what they reveal about the utility of each of the model- ing approaches. Table 7 describes several sample tweets that were labeled international affairs by the supervised model, and indicates how the unsupervised model labeled the same tweet. For ex- ample, the unsupervised model labeled the first tweet fea- tured as agriculture because of the presence of the hash- tag #FarmBill and mention of sorghum. At the same time, the tweet also reflects international affairs topical focus by mentioning the international trade market and naming other countries in that market. In this case, each of the supervised and unsupervised models captured different, but relevant, thematic focuses of the tweet. The second example where the models diverge was la- beled by the unsupervised model as emergency response (highest probability) or district affairs (second highest prob- ability). It is possible that the supervised model associated words like "proud", "send", and "help" with the interna- tional affairs topic, but the thematic focus of the tweet does indeed appear to be more related to emergency response and district affairs via discussion of "#FirstResponders", Hurricane Harvey, and mention of the geographies New York City and Texas. In this case, the unsupervised model captures more relevant themes than the supervised model. These disagreements illustrate that the fixed parameters of the CAP codebook may not capture all types of conversation by MCs on Twitter. Since the unsupervised model represents a bottom-up approach, it is able to capture a new topic not featured in the CAP codebook but that provides additional nuance to the analysis of these tweets. 8 Tweet Text Sorghum market is very dependent on export. China is main market w/ 75% of it, then Mexico. #FarmBill UN1 agriculture UN2 uninterpretable NYC is proud to send 120 #FirstResponders to help Texans in the wake of #Harvey https://t.co/vdumEKFnQA emergency response district affairs @realDonaldTrump @RepMcEachin @RepJoeKennedy Any time someone is brave enough to serve, we must respect that choice, not stomp on their rights and liberties. #TransRightsAreHumanRights civil rights veterans Table 7: Sample tweets labeled International Affairs by Supervised Classifier. UN1 refers to the maximum probability class according to the unsupervised classifier, and UN2 indicates the second-highest probability class. New Insights from the Unsupervised Model Recommended Uses of Each Model The second example in Table 7 raises another important difference between our supervised and unsupervised mod- els. Where our supervised model is limited by the policy- focused labels defined by the CAP codebook, our unsuper- vised model is not. We see that approximately 21.32% and 35.76% of all maximum probability and second maximum probability topics detected fall in topic codes that are not captured in the CAP codebook. These topics (a) reveal that MCs spend a significant portion of their tweets posting about issues other than policy and (b) identify the topics and be- haviors beyond policy that they exhibit. The additional topics the unsupervised classifier identi- fied largely reference activities related to personal relation- ship building. The ability to distinguish these activities en- ables analyses of behavior beyond policy debates and on topics such as "home style". For instance, the topics may make it possible to differentiate Fenno's (1978) "person- to-person" style from "servicing the district". Relationship- building topics included sports, holidays, awards, sympathy, constituent relations, and power relations. Service-related topics included district affairs, emergency response, and leg- islative process. Prior research has conducted similar style analysis on smaller sets of tweets around general elections (Evans, Cordova, and Sipole, 2014), and our models enable this analysis at scale and throughout the legislative and elec- tion calendars. That somewhere between 20 and 40 percent of all tweets are labeled with these topics tells us that the CAP codebook alone is unable to capture how and why MCs use Twitter. The supervised model does a good job of capturing the pol- icy topics present in the CAP codebook and facilitating the comparative analysis that codebook is designed to support. The unsupervised model enables us to see that MCs invest significant attention in personal relationship building and constituent service on Twitter and to analyze those topics and behaviors that are not clearly policy-oriented. 9 The supervised model performs well in assigning tweets top- ics from an existing measurement system, the CAP code- book, and should be used when researchers wish to do com- parative and/or longitudinal analyses. For instance, the su- pervised model facilitates studies that (a) compare topic attention on Twitter and in speeches (Back, Debus, and Muller, 2014; Greene and Cross, 2017; Quinn et al., 2010) or the news (Harder, Sevenans, and Van Aelst, 2017) and (b) compare topics in U.S. Congress with topics addressed by other governments (see Baumgartner, 2019, for many re- cent examples). Using an existing codebook like CAP fa- cilitates studies that rely on measurement models to study changes over time or to detect differences across contexts (Jones, 2016). The shared, established taxonomy, here the CAP codebook, is necessary for these types of analysis. The supervised model is also better able to capture rare topics. Because the model is trained on all categories, it learns to disambiguate topics such as housing and foreign trade that the unsupervised model does not detect. These relatively rare categories are significant objects of study de- spite their infrequency, and therefore the supervised model is a better tool for identifying and analyzing attention to those topics. The unsupervised model, on the other hand, is most use- ful for studying the particulars of the U.S. Congress and its Twitter behavior such as communication style and top- ics unique to the federal and state divisions of authority. The unsupervised model captures the topics and behaviors that MCs exhibit on Twitter that fall outside the purview of the CAP codebook and its related policy studies. For instance, the unsupervised model is a good resource for studying is- sues such as style (Fenno, 1978) and framing (Scheufele and Tewksbury, 2007). The topics this model detects in- clude things such as constituent service and district visit that can be useful for researchers trying to understand how Congress uses Twitter to communicate with its constituency broadly and not just about clear policy issues. The unsuper- vised model also allows us to relax the "mutually exclusive" criterion of the CAP codebook and to identify the overlap between topics such as energy and environment. It also re- veals the specificity of issues such as veterans' affairs that are distributed through the CAP codebook but emerge as one distinct issue area in MCs' tweets. In the following section, we articulate avenues for future research that leverage the models' strengths and weaknesses for different research ar- eas. Future Work Political Attention One promising set of next steps for research involve using the models to study political atten- tion and social media use in political communication. Our models dramatically reduce the costs of obtaining labeled data for comparative analysis (using the supervised model) and provide a mechanism for identifying additional behavior beyond policy discussions (using the unsupervised model). For example, by using our supervised model, we are able to study the complete 115th U.S. Congress and their relative attention to policies over time. We can then compare atten- tion between subgroups (e.g., parties, chambers, regions of the U.S.) and over time (e.g., around primaries, during re- cess). When combined with similar advances in using text as data in political science (Grimmer and Stewart, 2013), such as labeling and accessing news content (Saito and Uchida, 2018; Gupta et al., 2018) and bill text (Adler and Wilkerson), our models also facilitate analysis of the political agenda, enabling researchers to test the paths through which topics reach the mainstream news or enter legislation. The mod- els also facilitate studies of attention-related concepts such as agenda setting and framing (Scheufele and Tewksbury, 2007). By identifying the parties' rhetoric around a topic, the models make it possible to compare not just whether the parties talk about energy more or less frequently (using the supervised model) but how they discuss it and in combina- tion with what other issues or behaviors (using the unsuper- vised model). International Comparison Our supervised model di- rectly allows for comparative analyses by using a standard codebook designed for such studies. Whether our mod- els work on tweets in languages other than English (and marginally Spanish) is an open question. We are currently training models on German parliamentary tweets from 2017 in order to evaluate the potential utility of our approach for understanding politicians' public-facing rhetoric across dif- ferent languages and country contexts. Evaluating Non-Policy Related Topics The dataset we used to train the supervised model includes additional human-labeled binary tags indicating personal relationship or service-related content in the 113th Congress' tweets. Interestingly, many of these manual tags reflected simi- lar personal relationship or service-related tags that our unsupervised model independently detected. Future work could compare these results -- manual labels and unsuper- vised labels -- for this relational content and potentially in- form another useful computational tool. Model Improvements Our models leave some room for improvement, and alternative topic modeling techniques may achieve even more nuanced topic results. Niu's work with topic2vec modeling explores ways to ad- dress the issue of uninterpretable output from LDA models (Niu et al., 2015); he notes that because LDA assigns high probabilities to words occurring frequently, those words with lower frequencies of occurrences are less represented in the derivation of topics, even if they have more distin- guishable semantic meaning than the more frequently occur- ring words. In a similar approach to Moody ()moody2016, Niu tries to combine elements of word2vec and LDA mod- eling techniques to address the issue of under-specific topics resulting from pure LDA methods. His topic2vec approach yields more specific terms. We did not pursue topic2vec in our tests due to replicability issues encountered with the methodologies proposed, but they offer an interesting av- enue to explore in attempts to improve the model. Leveraging both LDA and community detection via mod- ularity provide an opportunity to compare the types of groupings that emerge from tweet texts in ways that incorpo- rate network structures and relationships (Gerlach, Peixoto, and Altmann, 2018). Efforts to merge topic modeling and community detection also offer additional opportunities to evaluate potentially alternative groupings in an unsupervised way (Mei et al., 2008). Each of these two approaches to un- supervised text group detection offer interesting opportuni- ties for comparative future work. Conclusion We provide computational models to facilitate research on political attention in social media. The supervised model classifies tweets according to the CAP codebook, enabling comparative analyses across political systems and reducing the labor required to label data according to this common codebook. The unsupervised model labels tweets according to their policy topic, social function, and behavior. It enables nuanced analyses of U.S. Congress, especially the intersec- tion of their policy discussions and relationship building. To- gether, these two models provide methodological tools for understanding the impact of political speech on Twitter and comparing political attention among groups and over time. Acknowledgments We are especially grateful to Annelise Russell for sharing her data and enabling us to train the supervised classifiers. This material is based upon work supported by the National Science Foundation under Grant No. 1822228. References Adler, E. S., and Wilkerson, J. Congressional bills project. http://www.congressionalbills.org/. Ac- cessed: 2019-5-3. Back, H.; Debus, M.; and Muller, J. 2014. Who takes the parliamentary floor? the role of gender in speech-making in the swedish riksdag. Polit. Res. Q. 67(3):504 -- 518. Barber´a, P.; Bonneau, R.; Egan, P.; Jost, J. T.; Nagler, J.; and Tucker, J. 2014. Leaders or followers? measuring politi- cal responsiveness in the US congress using social media 10 data. In 110th American Political Science Association An- nual Meeting. Barber´a, P.; Casas, A.; Nagler, J.; Egan, P.; Bonneau, R.; Jost, J. T.; and Tucker, J. A. 2018. Who leads? who follows? measuring issue attention and agenda setting by legislators and the mass public using social media data. Baumgartner, F. R., and Jones, B. D. 1993. Agendas and Instability in American Politics. University of Chicago Press. Baumgartner, F. R. 2019. Comparative Policy Agendas: Theory, Tools, Data. Oxford University Press. Benoit, K.; Conway, D.; Lauderdale, B. E.; Laver, M.; and Mikhaylov, S. 2016. Crowd-sourced text analysis: Repro- ducible and agile production of political data. Am. Polit. Sci. Rev. 110(2):278 -- 295. Bevan, S. 2017. Gone fishing: The creation of the compara- tive agendas project master codebook. Technical report. Bird, S.; Klein, E.; and Loper, E. 2009. Natural Language Processing with Python: Analyzing Text with the Natural Language Toolkit. O'Reilly Media, Inc. Bossetta, M. 2018. The digital architectures of social media: Comparing political campaigning on facebook, twitter, in- stagram, and snapchat in the 2016 U.S. election. Journal. Mass Commun. Q. 1077699018763307. Chang, J.; Gerrish, S.; Wang, C.; Boyd-graber, J. L.; and Blei, D. M. 2009. Reading tea leaves: How humans interpret topic models. In Bengio, Y.; Schuurmans, D.; Lafferty, J. D.; Williams, C. K. I.; and Culotta, A., eds., Advances in Neural Information Processing Systems 22. Curran Associates, Inc. 288 -- 296. Dowding, K.; Hindmoor, A.; and Martin, A. 2016. The com- parative policy agendas project: Theory, measurement and findings. J. Public Policy 36(1):3 -- 25. Evans, H. K.; Cordova, V.; and Sipole, S. 2014. Twitter style: An analysis of how house candidates used twitter in their 2012 campaigns. PS Polit. Sci. Polit. 47(2):454 -- 462. Fang, A.; Macdonald, C.; Ounis, I.; and Habel, P. 2016. Topics in tweets: A user study of topic coherence metrics In Advances in Information Retrieval, for twitter data. 492 -- 504. Springer International Publishing. Fenno, R. F. 1978. Home Style: House Members in Their Districts. Longman. Frechette, C., and Ancu, M. 2017. A content analysis of twitter use by 2016 US congressional candidates. The In- ternet and the 2016 Presidential Campaign 25. Gabel, M. J., and Huber, J. D. 2000. Putting parties in their place: Inferring party Left-Right ideological positions from party manifestos data. Am. J. Pol. Sci. 44(1):94 -- 103. Gerlach, M.; Peixoto, T. P.; and Altmann, E. G. 2018. A net- work approach to topic models. Science Advances 4(7). Golbeck, J.; Auxier, B.; Bickford, A.; Cabrera, L.; Conte McHugh, M.; Moore, S.; Hart, J.; Resti, J.; Rogers, A.; and Zimmerman, J. 2018. Congressional twitter use revisited on the platform's 10-year anniversary. Journal of the Association for Information Science and Technol- ogy 69(8):1067 -- 1070. Greene, D., and Cross, J. P. 2017. Exploring the political agenda of the european parliament using a dynamic topic modeling approach. Polit. Anal. 25(1):77 -- 94. Grimmer, J., and Stewart, B. M. 2013. Text as data: The promise and pitfalls of automatic content analysis meth- ods for political texts. Polit. Anal. 21(3):267 -- 297. Guggenheim, L.; Jang, S. M.; Bae, S. Y.; and Neuman, W. R. 2015. The dynamics of issue frame competition in tradi- tional and social media. Ann. Am. Acad. Pol. Soc. Sci. 659(1):207 -- 224. Gupta, S.; Sodhani, S.; Patel, D.; and Banerjee, B. 2018. News category network based approach for news source recommendations. In 2018 International Conference on Advances in Computing, Communications and Informat- ics (ICACCI), 133 -- 138. Harder, R. A.; Sevenans, J.; and Van Aelst, P. 2017. Interme- dia agenda setting in the social media age: How traditional players dominate the news agenda in election times. The International Journal of Press/Politics 22(3):275 -- 293. Haselmayer, M., and Jenny, M. 2017. Sentiment analy- sis of political communication: combining a dictionary approach with crowdcoding. Qual. Quant. 51(6):2623 -- 2646. Hellgren, K. A. 2012. Computing inter-rater reliability for observational data: An overview and tutorial. Tutorials in quantitative methods for psychology 8(1):23 -- 34. Hemphill, L.; Culotta, A.; and Heston, M. 2016. #polar scores: Measuring partisanship using social media con- Journal of Information Technology and Politics tent. 13(4):365 -- 377. Hemphill, L.; Otterbacher, J.; and Shapiro, M. 2013. What's congress doing on twitter? In Proceedings of the 2013 conference on Computer supported cooperative work, CSCW '13, 877 -- 886. New York, NY, USA: ACM. Hong, L., and Davison, B. D. 2010. Empirical study of topic modeling in twitter. In Proceedings of the First Workshop on Social Media Analytics, SOMA '10, 80 -- 88. New York, NY, USA: ACM. Hong, S., and Kim, S. H. 2016. Political polarization on twitter: Implications for the use of social media in digital governments. Gov. Inf. Q. 33(4):777 -- 782. John, P. 2006. The policy agendas project: a review. Journal of European Public Policy 13(7):975 -- 986. Jones, B. D. 2016. The comparative policy agendas projects as measurement systems: response to dowding, hindmoor and martin. J. Public Policy 36(1):31 -- 46. Karlsen, R. 2011. A platform for individualized cam- paigning? social media and parliamentary candidates in the 2009 norwegian election campaign. Policy & Internet 3(4):1 -- 25. 11 LaMarre, H. L., and Suzuki-Lambrecht, Y. 2013. Tweeting democracy? examining twitter as an online public rela- tions strategy for congressional campaigns'. Public Relat. Rev. 39:360 -- 368. Lau, J. H., and Baldwin, T. 2016. The sensitivity of topic coherence evaluation to topic cardinality. In HLT-NAACL. Lau, J. H.; Newman, D.; and Baldwin, T. 2014. Machine reading tea leaves: Automatically evaluating topic coher- ence and topic model quality. In Proceedings of the 14th Conference of the European Chapter of the ACL, 530 -- 539. Laver, M.; Benoit, K.; and Garry, J. 2003. Extracting policy positions from political texts using words as data. Am. Polit. Sci. Rev. 97(2):311 -- 331. Lehmann, P., and Zobel, M. 2018. Positions and saliency of immigration in party manifestos: A novel dataset using crowd coding. Eur. J. Polit. Res. 57(4):1056 -- 1083. McAuliffe, J. D., and Blei, D. M. 2008. Supervised topic models. In Platt, J. C.; Koller, D.; Singer, Y.; and Roweis, S. T., eds., Advances in Neural Information Processing Systems 20. Curran Associates, Inc. 121 -- 128. McHugh, M. L. 2012. Interrater reliability: the kappa statis- tic. Biochem. Med. 22(3):276 -- 282. Mei, Q.; Cai, D.; Zhang, D.; and Zhai, C. 2008. Topic modeling with network regularization. In Proceedings of the 17th International Conference on World Wide Web, WWW '08, 101 -- 110. New York, NY, USA: ACM. Michael, G., and Agur, C. 2018. The bully pulpit, social media, and public opinion: A big data approach. Journal of Information Technology & Politics 15(3):262 -- 277. Mikolov, T.; Chen, K.; Corrado, G.; and Dean, J. 2013. Ef- ficient estimation of word representations in vector space. Moody, C. E. 2016. Mixing dirichlet topic models and word embeddings to make lda2vec. Moon, S. J., and Hadley, P. 2014. Routinizing a new technol- ogy in the newsroom: Twitter as a news source in main- stream media. J. Broadcast. Electron. Media 58(2):289 -- 305. Murthy, D. 2015. Twitter and elections: are tweets, pre- dictive, reactive, or a form of buzz? Inf. Commun. Soc. 18(7):816 -- 831. Neuman, W. R.; Guggenheim, L.; Mo Jang, S.; and Bae, S. Y. 2014. The dynamics of public attention: Agenda- Setting theory meets big data. J. Commun. 64(2):193 -- 214. Nguyen, V.-A.; Ying, J. L.; and Resnik, P. 2013. Lexical and hierarchical topic regression. In Burges, C. J. C.; Bottou, L.; Welling, M.; Ghahramani, Z.; and Weinberger, K. Q., eds., Advances in Neural Information Processing Systems 26. Curran Associates, Inc. 1106 -- 1114. Oliver, J. E., and Rahn, W. M. 2016. Rise of the trumpen- volk: Populism in the 2016 election. Ann. Am. Acad. Pol. Soc. Sci. 667(1):189 -- 206. Pennebaker, J. W.; Booth, J.; and Francis, M. E. 2015. LIWC2015. Perotte, A. J.; Wood, F.; Elhadad, N.; and Bartlett, N. 2011. Hierarchically supervised latent dirichlet allocation. In Advances in Neural Information Processing Systems 24. Curran Associates, Inc. 2609 -- 2617. Quinn, K. M.; Monroe, B. L.; Colaresi, M.; Crespin, M. H.; and Radev, D. R. 2010. How to analyze political atten- tion with minimal assumptions and costs. Am. J. Pol. Sci. 54(1):209 -- 228. Rehurek, R., and Sojka, P. 2010. Software Framework for Topic Modelling with Large Corpora. In Proceedings of the LREC 2010 Workshop on New Challenges for NLP Frameworks, 45 -- 50. Valletta, Malta: ELRA. http:// is.muni.cz/publication/884893/en. Resnik, P.; Armstrong, W.; Claudino, L.; Nguyen, T.; Nguyen, V.-A.; and Boyd-Graber, J. 2015. Beyond LDA: exploring supervised topic modeling for depression- In Proceedings of the 2nd related language in twitter. Workshop on Computational Linguistics and Clinical Psychology: From Linguistic Signal to Clinical Reality, 99 -- 107. Rill, S.; Reinel, D.; Scheidt, J.; and Zicari, R. V. 2014. PoliTwi: Early detection of emerging political topics on twitter and the impact on concept-level sentiment analy- sis. Knowledge-Based Systems 69:24 -- 33. Roberts, M.; Stewart, B.; Tingley, D.; Lucas, C.; Leder- Luis, J.; Gadarian, S.; Albertson, B.; and Rand, D. 2014. Structural topic models for open-ended survey responses. American Journal of Political Science 58(4):1064 -- 1082. Roder, M.; Both, A.; and Hinneburg, A. 2015. Exploring the space of topic coherence measures. In Proceedings of the eight International Conference on Web Search and Data Mining, Shanghai, February 2-6. Russell, A. 2017. U.S. senators on twitter: Asymmetric party rhetoric in 140 characters. American Politics Re- search 1532673X17715619. Russell, A. 2018. The politics of prioritization: Senators' attention in 140 characters. The Forum 16(2):331 -- 356. Saito, T., and Uchida, O. 2018. Automatic labeling to clas- Interna- sify news articles based on paragraph vector. tional Journal of Computers 3. Scheufele, D. a., and Tewksbury, D. 2007. Framing, agenda setting, and priming: The evolution of three media effects models. J. Commun. 57(1):9 -- 20. Schofield, A., and Mimno, D. 2016. Comparing apples to apple: The effects of stemmers on topic models. Trans- actions of the Association for Computational Linguistics 4(0):287 -- 300. Shapiro, M. A., and Hemphill, L. 2017. Politicians and the policy agenda: Does use of twitter by the U.S. congress di- rect new york times content? Policy & Internet 9(1):109 -- 132. 12 Slapin, J. B., and Proksch, S.-O. 2008. A scaling model for estimating Time-Series party positions from texts. Am. J. Pol. Sci. 52(3):705 -- 722. Straus, J. R.; Glassman, M. E.; Shogan, C. J.; and Smelcer, S. N. 2013. Communicating in 140 characters or less: Congressional adoption of twitter in the 111th congress. PS Polit. Sci. Polit. 46(1):60 -- 66. Yu, B.; Kaufmann, S.; and Diermeier, D. 2008. Classifying party affiliation from political speech. Journal of Infor- mation Technology & Politics 5(1):33 -- 48. Zhao, W. X.; Jiang, J.; Weng, J.; He, J.; Lim, E.-P.; Yan, H.; and Li, X. 2011. Comparing twitter and traditional media using topic models. In Advances in Information Retrieval, Lecture Notes in Computer Science, 338 -- 349. Springer Berlin Heidelberg. 13
1511.01697
1
1511
2015-11-05T11:09:28
Evolving hypernetwork model based on WeChat user relations
[ "cs.SI" ]
Based on the theory of hypernetwork and WeChat online social relations, the paper proposes an evolving hypernetwork model with the competitiveness and the age of nodes. In the model, nodes arrive at the system in accordance with Poisson process and are gradual aging. We analyze the model by using a Poisson process theory and a continuous technique, and give a characteristic equation of hyperdegrees. We obtain the stationary average hyperdegree distribution of the hypernetwork by the characteristic equation. The numerical simulations of the models agree with the analytical results well. It is expected that our work may give help to the study of WeChat information transmission dynamics and mobile e-commerce.
cs.SI
cs
Evolving hypernetwork model based on WeChat user relations* Fu-Hong Wang Jin-Li Guo+ Ai-Zhong Shen Qi Suo Business School, University of Shanghai for Science and Technology, Shanghai, 200093 ,China Abstract: Based on the theory of hypernetwork and WeChat online social relations, the paper proposes an evolving hypernetwork model with the competitiveness and the age of nodes. In the model, nodes arrive at the system in accordance with Poisson process and are gradual aging. We analyze the model by using a Poisson process theory and a continuous technique, and give a characteristic equation of hyperdegrees. We obtain the stationary average hyperdegree distribution of the hypernetwork by the characteristic equation. The numerical simulations of the models agree with the analytical results well. It is expected that our work may give help to the study of WeChat information transmission dynamics and mobile e-commerce. Keywords: Social relation; hypernetwork; node aging; evolution model. * Project supported by the National Natural Science Foundation of China (Grant No. 71571119). + Corresponding author. E-mail: [email protected] 微信用户关系超网络演化模型 王福红 郭进利 沈爱忠 索琪 (上海理工大学 管理学院,上海 200093) 摘要:本文基于超网络理论,以微信在线社交关系为背景,建立节点具有吸引力与老化的非 均齐微信社交关系超网络模型。依据实际微信社交关系的特点,该模型中节点按照 Poisson 过程连续时间进入网络,并且随着时间的增长和社交平台的更新,节点不断老化。我们获得 模型超度的特征方程,利用特征方程对模型进行解析,计算机模拟结果与理论分析的结果一 致。本文结论为微商用户的营销管理提供理论上借鉴和参考。 关键词:社交关系;超网络; 节点老化; 演化模型 1 引言 随着互联网和信息技术的发展,出现了许多在线社交工具,如 facebook、微信、QQ 等等,在线社交工具的发展使人类的社交关系从现实的物理空间转向虚拟的在线网络空间。 传统的社交网络基于真实社会关系(如亲属、朋友、同事等)和现实的物理空间而建立,社交 关系简单,而在线社交网络集真实社会关系与虚拟社交关系于一体,跨越了真实的物理空间, 在线社交关系庞大复杂,在线社交工具逐渐成为信息传播的新媒介,使人际关系的演变发生 着深刻的变革。 微信是腾讯公司在 2011 年推出的一个为智能手机提供即时通讯服务的免费在线社交 网络平台。微信可以提供多种功能,包括向好友分享图片、文字,分组聊天、语音,一对多广播 消息,视频对讲、位置共享、视频或图片共享、互联网理财及购物、微信支付、信息交流联 系、游戏等。同时,用户也可以通过搜索号码、摇一摇、扫二维码、搜索附近的人、漂流瓶 等多种方式关注公众平台或者添加好友[1-5] 。微信支持跨通信运营商、跨操作系统平台。 截止到 2014 年 6 月,微信已经有了超过 6 亿的用户,用户呈几何级数增长,已成为移动互 联网最大的流量入口和亚洲最大即时通讯软件。 随着微信的快速发展,微信成为信息传播的新媒介,人们开始使用微信与家人、朋友、 同事联系,分享文字和图片,建立自己的“朋友圈”;也可进行网络营销、购物与支付; 还 可以接收新闻和广告信息等,给人们的日常生活、交友和工作带来了很大便捷。 2 同时,微信在线社交网络快速发展为电子商务的发展带来了机遇,基于微信平台的移 动电商—“微商”也随之快速发展,微商是指在微信在线社交平台上,利用微信朋友圈来销售 产品进行或提供服务,是一种新出现的销售模式和创业平台。因此本文将研究微信用户关系 网络的内部特征,探讨和分析微信用户关系(朋友圈)的拓扑结构和演化模型。 微信在线社交网络本身就是一个大型的复杂网络,有许多学者把复杂网络理论应用到 在线社交的研究中:Ebel[6]和 Ahn[7]等分别实证了电子邮件和韩国社交网站 Cyworld 是典型 的无标度网络,度分布近似服从幂律分布。罗由平 [8] 等实证了娱乐名人的微博子网络是小 世界无标度网络。Zhang 等[9]基于 BA 模型理论构建了一种增长、择优连接的在线社交网络 演化模型,仿真结果表明该在线社交网络度分布服从幂律分布。Xiong[10]等基于博客网络特 征构建了一种边和节点同时增长网络模型,该类型的在线社交网络的度分布也服从幂律分 布。王亚奇[11]等给出了节点带有吸引度的微博有向网络演化模型,具有无标度特性.度分布 指数不仅与反向连接概率有关,而且还取决于节点的吸引度分布。文献[12-15]基于复杂网络 理论知识,研究了社交网络上的信息传播演化模型、传播机制及信息推荐机制。文献[16]研 究了微信在学术图书馆服务中的应用,文献[17]对大学生的微信接收信息进行了研究,文献[18] 基于复杂网络的视角和 Agent 代理,研究微信在线社交网络知识传播演化模型, 文献[19] 采用复杂网络的视角,实证研究了微信子网络的拓扑结构特征及与之相关的信息传播。文献 [20]给出了带有微信功能的物联网框架,从技术的角度给出微信在物联网上的应用框架。用 复杂网络理论研究在线社交网络较多,然而采用超网络理论研究在线社交网络论文比较少。 研究微信应用的文章较多,然而对微信用户关系的形成和演化机制的研究则很少有人涉及。 本文采用超网络的研究视角,以微信社交关系网络为研究对象,将个人在微信中的朋 友关系(朋友圈)看作超边,将个人用户账号看作节点,节点按 Poisson 过程进入网络,建 立了一个节点具有寿命和吸引度的微信用户关系非均齐超网络演化模型,利用 Poisson 过程 理论和连续化方法对模型进行分析,获得超网络稳态平均超度分布的解析表达式,研究结果 表明:随着网络规模的增长,老化指数增大,这个动态演化的非均齐超网络的超度分布由幂 律分布向指数分布转变。仿真结果和解析结果相吻合。这一研究结果可以为基于微信平台的 电子商务(微商)在市场营销策略提供理论上的参考;也可为在线社交网络的传播动力学研 究、网络传播控制以及信息的推荐提供某些借鉴意义。 2 超网络定义 目前对超网络的研究尚处于起步阶段, 关于超网络的概念尚没有统一的定义,目前对 3 超网络的定义主要分为两类: (1) 一类超网络的定义是由Denning[21]提出的:基于网络的超网络(Supernetworks),即网络 中的网络NON(Networks of Networks)。 (2) 另 一 类 超 网 络 的 定 义 是 Esrada[22-23] 提 出 的 基 于 超 图 (Hypergraph) 的 超 网 络 (Hypernetworks),凡是可以用超图表示的网络就是超网络。 文本的研究是基于超图理 论的视角。 超图的定义[21][24]如下: 设 V = vv ,{ 1 2 ,..., nv } 是一个有限集,若 (1) Ei i ( ≠φ = ,..,2,1 m ) , (2) 且 m =1U i VEi = ,记 h E = EE ,{ 1 2 ,..., E m } 则称二元关系 hEVH = ( , ) 为超图,简记为 hEV ( , ) 或 H 。其中V 的元素称为超图的节点, hE 中的元素称为超图的超边。如果两个节点属于同一条超边,则称这两个节点邻接;如果 两条超边的交集不空,称之为这两条超边邻接。如图 1(a)中,超图 ),( EVH = =V { }6 vvvvvv , 1 , , , , 5 4 3 2 , 超 边 集 = { =2E }4 { 1,vv , =3E { }5 vvv , 1 , 3 , =4E { }6 vvv , 3 , 5 , 2 3 4 , , , , }5 EEEEE 1 { }6 vvv , 2 =5E , 5 , 1E = { { }6 1,vv , =6E , 顶点集 }6 vvv , 4 , 2 , 。如果每条超 边中的顶点数都相等, 则称为均匀超图或一致超图。如果V 和 hE 均有限,则称 H 为有限 超图, )hEVH ( = , 退化为图。 也可以采用不同方法来描述复杂系统, 如图 1(a)中的 超图可以转化复杂网络理论中的二分图。如图 1(b)所示。 (a)超图 (b) 二分图 图 1 超图和二分图示意图 4 超网络[25]是超图的推广,假设 EV=Ω , { h (), EV , h } ,G 是从 ) 是有限超图 T [ = ,0 )+∞ 到 Ω 的映射,对于任意给定的 ,0≥t tG )( = tV ( t h (E),( )) 是一个有限超图,指标t通常被认为是 时间。超网络{ }TttG ∈)( 是指超图的集合。 3 微信非均齐超网络演化模型 微信在线社交网络规模庞大,拓扑结构复杂,并且存在安全性问题,直接将微信在线 社交网络平台作为实验对象进行研究和分析是十分困难的[7]。因此,本文试图根据微信在线 社交网络的特点,对微信网络的拓扑结构进行模型抽象,从而以拓扑模型代替实际的微信在 线社交网络,通过拓扑模型认识社交网络的基本特性并进行相关研究。 微信在线社交网具有以下特点: (1)在微信在线社交网络中,将个人的朋友圈视作超边,朋友圈中的好友看作节点, 节点按 Poisson 过程进入网络,在每时每刻,都可能有新用户申请账号加入社交网络,当新 用户个体加入微信社交网络后,会选择老用户成为朋友关系,这时,微信在线社交网络中就 会形成一个新的朋友圈,也就是形成一条新的超边。每个新个体选择的好友的数量是不一致 的,即具有非均齐特点。在微信用户关系超网络中,用户朋友圈中的人数越多,该微信用户 越容易被连接到新加入的用户。个人用户所拥有的朋友圈个数为该用户所代表的网络节点的 超度。超度越大的用户,拥有的朋友圈越多,越容易与新加入的朋友形成新的超边。微信用 户朋友关系超网络示意图如图 2 所示: 图 2 微信用户朋友关系超网络示意图 E1,E2..E3 代表朋友圈,节点代表用户。 (2)一些新加入网络不久的节点由于某种经验或声望等某种原因,也可能成为被迅速 关注的对象,那么就会出现该节点朋友圈的快速增长,成为微信社交网络中表现活跃的“积 5 极分子”,节点的这种不同的“活跃性”我们认为:新加入在线社交网络的每一个(或批)个 来表示,如图 3 所示。吸引度可以是均匀分 体的拥有的“吸引度”不同,吸引度用 y L1 0, y ny 布、指数分布或幂律分布等其中的一种。节点所带的吸引度越大户,越容易与微信在线社交 网络中的老节点形成新的超边。 图3 带有不同吸引度的节点进入微信在线社交网络示意图 (3) 人们在起初申请一个微信账号加入微信社交网络,我们通常的表现比较积极-活 跃度较高,随着时间的推移,我们一般会降低活跃度,使用率不断降低,甚至最终可能不再 与账号中的朋友联系。这可能是我们转向其他在线社交应用或者是我们失去“新鲜感”。这种 活跃度的降低我们可以看作节点不断的老化。即节点具有寿命。 关于超网络演化模型是近几年的研究热点,Wang 等给出了一种基于超图的超网络动态演化 模型, 该模型采用增长和优先连接机理逐步生成超网络, 每次新增加若干个节点, 将这若干个新 节点和网络中已有的1 个节点结合生成超边, 且每个时间只增加一条超边[26]. 胡枫等给出了另 一种基于超图的超网络动态演化模型, 该模型增长机理与王建伟等模型相对偶, 每次新增加1 个 节点, 将这个新节点和网络中已有的若干个节点结合生成超边, 且每个时间只增加一条超边[27]。 我们在文献[28]中研究了一类统一模型。然而,这些模型均没有考虑节点吸引力和老化问题。以 下我们依据微信网络的特点,建立Poisson连续时间增长的节点老化超网络演化模型,模型描述 如下: 1) 初始化:开始于较少的节点数量( 0m )的连通超图; 2) 增长:开始于较少的节点数量( 0m )的超图,节点到达过程是具有强度为λ的Poisson 过程 )(tN ,在t 时刻,当第 )(tN 批新节点进入网络时,从概率密度为 )(ηρ 的正整数 中抽取 )(tNη ,从概率密度为 )(yf 的非负实数中抽取 )(tNy ,且 m 1 ηηηρ d )( +∞< = ∫ , 6 a yf dy y )( +∞< = ∫ 络中已有的 2m 个老节点围成一条超边,共围成 m 条超边,且不出现重超边, . 第 )(tN 批新节点指定的吸引力为 )(tNy ,这 )(tNη 个新节点与网 mm ≤ ; 2 m 0 3) 择优连接: 在选择新节点的连接时,假设新节点连接到节点i 的概率 ∏ 取决于节点i 的 超度数 ik 和它的年龄,即满足 ∏ ( k ) i = k i ( + k i y + i )( y i t )( − t t i − ) t ( ∑ i 2/1 − ) − i 2/1 (1) 其中, it 是节点i 进入微信社交网络的时刻, it t − 为节点i 的年龄。 4、模型分析 假设 tk i 为节点i 在时刻t 的超度,则它满足下面的动态方程 t ),( tk t ),( ∂ i t ∂ = mm 2λ t y tk ),(( + i ∑ tk t ), ([ + j j t )( − i y t ]( j t i − ) t − j 2/1 ) 2/1 − , mttk ),( = (2) 方程(2) 中λ表示新节点的到达率。 t tk ),(( j + y j t )( − t ) j ∑ j − 1 2 = ∫ yf )( t ∫ 0 tsk ),(( + ty )( − s ) − 1 2 dydsm λ 1 方程(2)化为 tsk ),( ∂ t ∂ = mm 2 tsk ),(( ∫ 0 t yfm 1 tsk ),(()( ∫ + y 1)( − ts )/ − 1 2 + y 1)( − ts )/ − 1 2 dyds tsk ),( ≡+ y yxg ,( ) 令 x = , s t 那么,方程(3)化为 , mttk ),( = (3) − s t 2 g ∂ x ∂ = mm 2 tm 1 ∫ − 1 2 1)( − x ) yxg ,( 1 ∫ 0 yf )( yxg ,( 1)( − x ) − 1 2 dydx , g ,1( ymy ) + = (4) 7 记 θ = yf )( ∫ 1 ∫ 0 yxg ,( 1)( − x ) − 1 2 dydx ,则 ) 1 yxg ,( g ∂ x ∂ ti 到1积分,得 对于方程(5)两边从 t −= mm 2 1 xm θ 1 − x , g ,1( ymy ) = + (5) 所以 ) tg y ( , i t ym + ln = ln 2 mm m θ 1 1 + 1 − 1 − 1 − ⎛ ⎜ ⎜ ⎜ ⎜ ⎝ t i t t i t ⎞ ⎟ ⎟ ⎟ ⎟ ⎠ t tk ),( i = tg ( i t ) = ( ym + ) 1 + 1 − 1 − 1 − ⎛ ⎜ ⎜ ⎜ ⎜ ⎝ t i t t i t 2 mm m θ 1 ⎞ ⎟ ⎟ ⎟ ⎟ ⎠ − y (6) 其中,θ是如下特征方程的正解 1 ∫ 0 2 mm m θ 1 1( 1 + − x x ) xdx − mm 2 + amm (2 1 ) − 1 2 = 0 (7) 从(6)式,我们有 tkP t ),(( i ≥ k ) = tP ( i ≤ (4 (( k + ym ) m θ 1 mm 2 y ) + m θ 1 mm 2 ( k + y ) + ( ym + ) m θ 1 mm 2 m θ 1 mm 2 t ) 2 ) (8) 由Poisson过程理论,我们知道节点到达时间 it 服从参数为i 和λ的Gamma分布 ,( λiΓ ) ,因此, (4 tP ( i ≤ + ym ) m θ 1 mm 2 y ) + m θ 1 mm 2 ( k + y ) + ( ym + ) (( k (4 − ym ) + m θ 1 mm 2 yk + ) m θ 1 mm 2 ( yk + + ( ym + ) m θ 1 mm 2 ) m θ 1 mm 22 ) 1 −= e (( t λ i 1 ∑− l = 0 m θ 1 mm 2 m θ 1 mm 2 1 l ! ⎛ ⎜ ⎜ ⎜ ⎝ t ) 2 ) (4 + ym ) m θ 1 mm 2 y ) + (( k m θ 1 mm 2 ( k + y ) + ( ym + ) m θ 1 mm 2 t λθ m 1 mm ) 2 2 l ⎞ ⎟ ⎟ ⎟ ⎠ (9) 8 由此,我们可以获得连续增长微信社交网络模型的稳态平均超度分布为 m 4)( θ ∫ kP 1 ≈ mm 2 ( ym + ) m θ 1 mm 2 ( k + y ) m θ 1 mm 2 1 − k [( + y ) m θ 1 mm 2 ym ( + ) m θ 1 mm 2 ] dyyf )( m θ 1 mm 2 k [( + y ) + ( ym + ) − m θ 1 mm 2 ] 3 (10) 其中,θ是如下特征方程(7)的正解. 100 10-1 10-2 10-3 ) k ( P 10-4 10-5 10-6 100 101 k 102 103 图4 微信社交网络模型模拟图。 +表示模拟度分布,直线表示理论公式(10)预测 的理论曲线。网络规模100000,初始网络20个节点,新节点在1~5的整数中 随机抽取, 2=m , 2 =m 6 ,节点吸引力为 )(tNy 服从[0,1]上的均匀分布。 5 老化指数普适性模型 上述分析和数学解析假设 Poisson 连续时间增长社交网络模型老化指数为 21=α ,不 失一般性,下面我们建立老化指数普适性的模型并利用计算机仿真研究老化指数对于微信 9 社交网络超度分布的影响。 模型:增长与 Poisson 连续时间增长的节点老化超网络演化模型相同;在选择新节点的 连接时,假设新节点连接到节点i 的概率 ∏ 取决于节点i 的度数 ik 和i 的年龄 it t − ,即满足 =∏ ) ( k i k ( + i ∑ k ( i i y i + t )( − y t )( i t i − ) t i − α ) − α (11) 其中, it 是节点i 进入网络的时刻,α是一个非负常数。 这个模型具有一定的普适性,文献[29]中的模型也是这个模型的特殊情形。这个模型的 几个特例仿真参见图 5,可见随着α的变大分布指数不断增大,当 1=α 时,超度分布接近 于指数分布。这也是可以理解的,因为节点的超度不会超过 tλ ,当 1=α 时,择优条件(11) 就接近于随机选择。 100 10-1 10-2 10-3 ) k ( P 10-4 10-5 10-6 100 101 102 k 103 104 图5 带有老化指数普适性的微信社交网络模拟图。O表示 1.0=α 模拟度分布,+ 表示 5.0=α 模拟度分布,*表示 9.0=α 模拟度分布。网络规模100000,初 始网络20个节点,新节点在1~5的整数中随机抽取, 2=m , 2 =m 6 ,节点 吸引力为 )(tNy 服从[0,1]上的均匀分布。 10 6 结论 在微信用户关系超网络演化模型研究中发现,随着老化指数的增大,超度分布由 幂律分布向指数分布转化。这一研究发现:可以为微商用户营销决策提供如下的管理 启示: (1)当微信超网络的超度分布具有幂律分布时,这时的超网络具有“马太效应”, 即有“富者越富”效应。即当“微商”的朋友圈形成的超网络具有“幂律”分布, “潜在的 客户群(或朋友圈)”与微商连接时,容易形成“择优选择”,此时的微信(微商)用户 关系超网络可以得到更多的市场份额和潜在用户,容易形成规模,取得最优的经济效 益。 (2)如果节点的老化加快,微信超网络的超度分布由幂律分布转化为指数分布 时,“潜在的客户群(或朋友圈)与“微商”的容易连接由“择优选择”向“随机选择”转化, 这时会导致潜在的客户群比较分散,不容易形成规模效益。 为了避免整个微信商圈网络中的节点老化现象,避免节点的兴趣度降低和节点 退出,防止微信在线超网络由幂律分布向指数分布转化, 因此“微商”在进行市场营 销时,应及时地维护良好的客户互动关系,对一些不太活跃的用户和一段时间没有联 系的客户,利用节假日和促销周进行问候或推送产品信息,或者定期浏览不活跃用户 分享的信息,及时掌握不活跃用户的现状,不定期的建立联系。“微商”也要通过推送 一些引起朋友圈兴趣的内容,保持“节点”一直处于活跃状态,积极避免客户节点的老 化和吸引度下降的现象,维持微信超网络处于幂律分布状态以取得最优的经济效益。 在线社交关系复杂繁多,其演化过程非常复杂,只有理解在线社交网络上的演化 过程,建立符合实际的演化模型,我们才能够有依据地进行社交网络的传播动力学研 究、网络传播控制以及信息的推荐等的研究。 11 参考文献: [1]王瑶. 微信与微传播[J]. 传媒观察, 2013, 2: 39-41. [2]朱超峻. 基于微信的新型移动电子商务[J]. 科技资讯, 2015, 5: 133. [3]徐丽, 张扬. 国内微信研究现状综述[J]. 科技传播, 2015, 3: 090. [4]曹畅, 郭双双, 赵岩, 等. 大学生微信朋友圈发帖特点及原因探讨[J]. 中国青年研 究, 2015, 4: 013. [5] 方兴东, 石现升, 张笑容, 等. 微信传播机制与治理问题研究[J]. 现代传播, 2013, 6: 122-127. [6] 王 亚 奇, 王 静, 杨 海 滨. 基 于 复 杂 网 络 理 论 的 微 博 用 户 关 系 网 络 演 化 模 型 研 究[J]. 物 理 学 报,2014,20:408-414. [7] 罗 由 平 ; 周 召 敏 ; 李 丽 等 . 基 于 幂 率 分 布 的 社 交 网 络 规 律 分 析 [J] 计 算 机 工 程 2015,40(7),299-302 [8] Ebel H, Mielsch I, Bornholdt S. Scale-free topology of E-mail networks[J]. Physical Review E, 2002, 66(3):35-103. [9] Ahn Y Y, Han S, Kwak H, Moon S, Jeong H. Proceedings of the 16th International Conference on World Wide Web Banff,Canada,2007. [10] Zhang L,Liu Y. Research on the evolution process of virtual community networks [J]. Acta Phys Sin,2008, 57(9):5419 -5424. [11] Xiong F,Liu Y,Si X M, et al. Network model with synchronously increasing nodes and edges based on Web2.0 J].hys Sin,2010,59( 10):6889 -6894. [12]刘衍珩, 李飞鹏, 孙鑫,等. 基于信息传播的社交网络拓扑模型[J].通信学报, 2013,34(4):1-9. [13]张彦超,刘云,张海峰,等. 基于在线社交网络的信息传播模型[J]. 物理学 报,2011,60( 5). [14]赵文兵,赵宇翔,朱庆华,等. Web2. 0 环境下社交网络信息传播仿真研究 12 [J]. 情报学报, 2013,32( 5) : 511-521. [15] Kim Y, Shim K. Twitobi: A recommendation system for twitter using probabilistic modeling[C] Data Mining (ICDM), 2011 IEEE 11th International Conference on. IEEE, 2011: 340-349. [16] Xu J, Kang Q, Song Z, et al. Applications of Mobile Social Media: WeChat Among Academic Libraries in China[J]. The Journal of Academic Librarianship, 2015, 41(1): 21-30. [17]Hua X, Qi W, Zhang S. Research on Undergraduates' Perception of Wechat Acceptance[C] e-Business Engineering (ICEBE), 2014 IEEE 11th International Conference on. IEEE, 2014: 61-67. [18]Chen S, He W. Study on Knowledge Propagation in Complex Networks Based on Preferences, Taking Wechat as Example[C] Abstract and Applied Analysis. Hindawi Publishing Corporation, 2014, 2014. [19] Zhu J, Wang Q, Yang J. Research of Wechat Network Information Transmission based on the Complex Network[C] 2015 International Conference on Intelligent Systems Research and Mechatronics Engineering. Atlantis Press, 2015. [20] Yitong H, Xiaozheng L, Bingpei D, et al. Web-of-Things Framework for WeChat[C] Green Computing and Communications (GreenCom), 2013 IEEE and Internet of Things (iThings/CPSCom), IEEE International Conference on and IEEE Cyber, Physical and Social Computing. IEEE, 2013: 1496-1500. [21] Berge C . Graphs and hypergraphs [M] .New York: Elsevier, 1973. [22]Estrada E, Rodríguez-Velázquez J A. Subgraph centrality and clustering in complex hyper-networks[J]. Physica A: Statistical Mechanics and its Applications, 2006, 364: 581-594 [23]Estrada E, Rodriguez-Velazquez J A. Subgraph centrality in complex networks[J]. Physical Review E, 2005, 71(5): 056103. 13 [24] 王众托. 关于超网络的一点思考[J]. 上海理工大学学报,2011,33(3): 229-237. [25] Guo J L,Suo Q. Brand effect versus competitiveness in hypernetworks[J].Chaos: An Interdisciplinary Journal of Nonlinear Science. 2015, 25, 023102. doi: 10.1063/ 1.4907016. [26] Wang J W, Rong L L, Deng Q H, et al. Evolving hypernetwork model[J]. The European Physical Journal B-Condensed Matter and Complex Systems, 2010, 77(4): 493-498. [27]胡枫, 赵海兴, 马秀娟. 一种超网络演化模型构建及特性分析[J]. 中国科学, 2013, 43(1): 16-22. [28] 郭进利, 祝昕昀.超网络中标度律的涌现 [J]. 物理学报, 2014, 63(9): 90207. [29] Hu F, Zhao H X, Zhan X Z, Liu C, Zhang Z K. Evolution of citation networks with the hypergraph formalism. arXiv:1406.0936. 14
1610.08098
2
1610
2017-09-18T16:50:12
The Effect of Pok\'emon Go on The Pulse of the City: A Natural Experiment
[ "cs.SI" ]
Pok\'emon Go, a location-based game that uses augmented reality techniques, received unprecedented media coverage due to claims that it allowed for greater access to public spaces, increasing the number of people out on the streets, and generally improving health, social, and security indices. However, the true impact of Pok\'emon Go on people's mobility patterns in a city is still largely unknown. In this paper, we perform a natural experiment using data from mobile phone networks to evaluate the effect of Pok\'emon Go on the pulse of a big city: Santiago, capital of Chile. We found significant effects of the game on the floating population of Santiago compared to movement prior to the game's release in August 2016: in the following week, up to 13.8\% more people spent time outside at certain times of the day, even if they do not seem to go out of their usual way. These effects were found by performing regressions using count models over the states of the cellphone network during each day under study. The models used controlled for land use, daily patterns, and points of interest in the city. Our results indicate that, on business days, there are more people on the street at commuting times, meaning that people did not change their daily routines but slightly adapted them to play the game. Conversely, on Saturday and Sunday night, people indeed went out to play, but favored places close to where they live. Even if the statistical effects of the game do not reflect the massive change in mobility behavior portrayed by the media, at least in terms of expanse, they do show how "the street" may become a new place of leisure. This change should have an impact on long-term infrastructure investment by city officials, and on the drafting of public policies aimed at stimulating pedestrian traffic.
cs.SI
cs
The E(cid:27)ect of Pokémon Go on The Pulse of the City: A Natural Experiment∗ Eduardo Graells-Garrido†, Leo Ferres, Diego Caro, Loreto Bravo Data Science Institute, Faculty of Engineering, Universidad del Desarrollo Telefónica R&D Chile Abstract Pokémon Go, a location-based game that uses augmented reality techniques, received unprecedented media coverage due to claims that it allowed for greater access to public spaces, increasing the number of people out on the streets, and generally improving health, social, and security indices. However, the true impact of Pokémon Go on people's mobility patterns in a city is still largely unknown. In this paper, we perform a natural experiment using data from mobile phone networks to evaluate the e(cid:29)ect of Pokémon Go on the pulse of a big city: Santiago, capital of Chile. We found signi(cid:27)cant e(cid:29)ects of the game on the (cid:30)oating population of Santiago compared to movement prior to the game's release in August 2016: in the following week, up to 13.8% more people spent time outside at certain times of the day, even if they do not seem to go out of their usual way. These e(cid:29)ects were found by performing regressions using count models over the states of the cellphone network during each day under study. The models used controlled for land use, daily patterns, and points of interest in the city. Our results indicate that, on business days, there are more people on the street at commuting times, meaning that people did not change their daily routines but slightly adapted them to play the game. Conversely, on Saturday and Sunday night, people indeed went out to play, but favored places close to where they live. Even if the statistical e(cid:29)ects of the game do not re(cid:30)ect the massive change in mobility behavior portrayed by the media, at least in terms of expanse, they do show how "the street" may become a new place of leisure. This change should have an impact on long-term infrastructure investment by city o(cid:28)cials, and on the drafting of public policies aimed at stimulating pedestrian tra(cid:28)c. Keywords. Pokémon, Mobile Phone Data, Call Detail Records, Floating Population, Urban Informatics. 7 1 0 2 p e S 8 1 ] I S . s c [ 2 v 8 9 0 8 0 . 0 1 6 1 : v i X r a ∗ This is the author's version. The published version is available at the EPJ Data Science journal in https://doi.org/10.1140/epjds/ s13688-017-0119-3. † Corresponding author: [email protected]. 1 1 introduction 1 introduction 2 Pokémon Go is a location-based mobile game about capturing and "evolving" virtual characters that appear to exists in the same real-world location as players. As soon as it came out, people of all ages seemed to be caught in the frenzy of walking everywhere trying to (cid:27)nd the next pocket monster. As it became world-wide hit, the game has fueled a (cid:30)urry of speculation about its potential e(cid:29)ects. It has been suggested, for example, that the game made kids and adults move out of the living room and into the open air, and that touristic attractions would attract more people if they had a Pokéstop (a place to check-in and get items), among many others. Real or not, Pokémon go has had some real-world e(cid:29)ects, some of which are not ideal: governments issuing alerts on playing the game in mine(cid:27)elds,1 searching for Pokémon in "inappropriate" places like the Holocaust Museums and the White House,2 and even to causing accidents.3 The game was so popular, that in some countries it reached engagement rates that surpass those of mainstream social platforms like Twitter and Facebook.4 The general perception is that games like Pokémon Go and its predecessor, Ingress [1], could make whole populations change their mobility patterns through a reward-system: earning more points by catching creatures, getting to certain places and checking in, among other well-known gami(cid:27)cation techniques. Ingress and Pokémon Go have a laxer de(cid:27)nition of "check-points" than a city's usual Points of Interest (POIs, such as museums and parks) including, for example, gra(cid:28)ti [2] and hidden heritage [3]. Thus, these games may help motivate visiting di(cid:29)erent kinds of places from the usual POIs. Because people tend to visit few POIs in their daily routines [4], playing the game implies that people would tend to visit di(cid:29)erent places from those they would usually visit. If this is the case, and considering that Pokémon is one of the most successful media franchises in the world [5], providing empirical evidence in favor (or against) this folk hypothesis would help understand the level to which these games make people change their habits. In this study, we seek to quantify the Pokémon Go E(cid:29)ect on the pulse of a city, as seen from its (cid:30)oating population patterns. The "(cid:30)oating population" concept denotes the number of people present in a given area during a speci(cid:27)c period of time, but who do not necessarily reside there. For instance, people who work in a business district are part of its (cid:30)oating population, since they probably reside elsewhere. Given the successful launch of Pokémon Go in Chile and the availability of mobile phone network data, we are able to ask sophisticated questions about (cid:30)oating population such as whether Pokémon Go has an e(cid:29)ect on it at the city-scale; and if so, what the characteristics of these e(cid:29)ects are. In Chile, Pokémon Go was o(cid:28)cially launched on August 3rd, 2016. Reports indicate that more than one million people downloaded the game within the next (cid:27)ve days.5 To understand the game e(cid:29)ects, we based our analyses on a set of mobile communications records from Telefónica Movistar, the largest telecommunications company in Chile, with a market share of 33% in 2016. We used a dataset that follows the Call Detail Records structure, i. e., a dataset built for billing purposes, from July 27th, until August 10th. CDR datasets usually include logs of mobile phone calls, SMS's, and data-type network events (e. g., Web browsing, application usage, etc.), aggregated by a context-dependent amount of downloaded information [6]. Even though we cannot know who is playing the game, we hypothesize that this is not needed to evaluate the city-level e(cid:29)ect: our aim is to measure how many people were on the streets before and after the release of the game. 1 http://goo.gl/AvjpGL 2 http://goo.gl/TWeI86 3 http://goo.gl/d69rjS 4 https://goo.gl/lqwfUb 5 https://goo.gl/T2pthM 2 data and methods 3 We followed a natural experiment approach whereby we evaluated (cid:30)oating population patterns at two speci(cid:27)c intervals of time: seven days before and seven days after the launch of Pokémon Go. We selected a speci(cid:27)c number of devices to ensure that we only analyzed (cid:30)oating population patterns of active users who live in the city (see Section 2.1 for the (cid:27)ltering process). Given this, we assumed, conservatively, that a higher number of connected mobile devices meant a higher number of people on the streets. Then, using regression models suitable for count data, we evaluated whether the launch of the game had an impact on the (cid:30)oating population by individually testing each regression factor for signi(cid:27)cance. Our aim was to measure the factor associated to the game itself [7]. We explored how spatio-temporal properties of mobility were related to the Pokémon Go e(cid:29)ect. To do so, we also used complementary datasets that are either generally available, such as travel surveys, or that could be approximated using mobile phone data (e. g., land use). Hence, the methods presented in this paper can be used to perform a similar analysis in other cities, as well as monitoring for pattern changes. The contributions of this work are two-fold. First, we introduce a methodology to analyze mobile records that allowed us to identify behavioral changes at the city level. Second, we provide a case study of a city in a developing country: Santiago of Chile, and report several empirical insights about the observed phenomena. To the extent of our knowledge, this is the (cid:27)rst large-scale study on the e(cid:29)ect of an external factor (a location-based augmented reality game) on the (cid:30)oating population of a city. The main (cid:27)ndings of our work are as follows: (cid:27)rst, there is a signi(cid:27)cant e(cid:29)ect of the availability of Pokémon Go on Santiago's (cid:30)oating population patterns, including covariates that account for daily patterns, land use, and available points of interest. The highest e(cid:29)ect during business hours was found at 12:31, with 13.8% more people connected to mobile networks. After business hours, the strongest e(cid:29)ect was found at 21:31, with 9.6% more people connected to mobile networks. Second, during business hours, the e(cid:29)ect is signi(cid:27)cant at commuting times between important places (such as home and work) and break hours (e. g., lunch times). We conclude that people adapted their routines to play the game, concentrating geographically in places with a high (cid:30)oating population. Unlike those e(cid:29)ects found during business hours, Pokémon Go players were scattered around the city at night, which hints at the possibility that people played the game near their places of residence at times when they were usually indoors. Finally, we discuss our (cid:27)ndings in the light of practical and theoretical implications in the areas of urbanism and the social life of the city. 2 data and methods We focused our study on Santiago, the most populated city in the country, with almost 8 million inhabitants. Comprising an area of 867.75 square kilometers, urban Santiago is composed of 35 independent adminis- trative units called municipalities. The city has experienced accelerated growth in the last few decades, a trend that has been predicted to continue at least until 2045 [8]. Chile, and Santiago in particular, is one of the developing regions of South America with the highest mobile phone penetration index. There are about 132 mobile subscriptions per 100 people.6 Santiago's growth and the general availability of mobile phones makes it an excellent city to perform research based on mobile communication data. 2.1 Datasets We use the following complementary datasets: 6 https://goo.gl/sjWEjS 2 data and methods 4 Santiago Travel Survey and Tra(cid:28)c Analysis Zones. The Santiago 2012 Travel Survey7 (also known as Origin-Destination survey, or ODS) contains 96,013 trips from 40,889 users. The results of this survey are used in the design of public policies related to transportation and land use. The survey includes tra(cid:28)c analysis zones of the entire Metropolitan Region, encompassing Santiago and nearby cities. We use this zoning resource for two reasons. On the one hand, the extent and boundaries of each area within a zone take residential and (cid:30)oating population density, administrative boundaries, and city infrastructure into account. This enables the comparison of several phenomena between zones. On the other hand, it allows us to integrate other sources of information, providing results that can be compared to other datasets such as land use properties [9]. The complete survey includes 866 zones; however, we were interested in urban areas of a single city. Since these are densely populated, we restricted our analysis to zones with a surface of under 20 square Km. As result, the maximum zone area is 18.37 square Km., with mean 1.34 and median 0.72 square Km. Finally, we were interested in zones that have both cell phone towers and Pokémon points of interests (see Figure 1), resulting in 499 zones covering 667 km2, about 77% of Santiago. Ingress Portals/Pokémon Points of Interest. Before Pokémon Go, Niantic Labs launched Ingress [1] in 2012. Ingress is a location-based game where players choose one team (from two available), and try to hack (take control) several portals placed in real locations world-wide. Portal locations are crowd-sourced and include "a location with a cool story, a place of historical or educational value," "a cool piece of art or unique architecture," "a hidden-gem or a hyper-local spot," among others.8 The de(cid:27)nition of a portal, thus, includes points of interest that go beyond the de(cid:27)nition used in, for instance, check-in based social networks [2]. Once a portal is "hacked," it belongs to the corresponding faction. A set of portals belonging to the same faction de(cid:27)nes the limit of an area controlled by it. Since players need to be close to portals to hack them, this makes players explore the city to (cid:27)nd portals to hack and conquer for their own teams. Pokémon Go shares many game mechanics with Ingress, including the team concept. The main di(cid:29)erence between the games is that while in Ingress players capture portals, in Pokémon Go they capture wild pocket monsters. A subset of Ingress portals is de(cid:27)ned to be a PokéStop (a place to check-in and get items) or a PokéGym (a place to battle against the Pokémon of other factions). In this paper, both are referred to as PokéPoints. Additionally, there are hidden Pokémon respawn points, where di(cid:29)erent creatures tend to appear. The main mechanic of the game is that players must walk around and explore to (cid:27)nd creatures to capture. Note that all players see the same creatures, and one creature may be captured by many players. The game motivates walking in two ways: (cid:27)rst, walking to points of interests that are scattered around city (see Figure 1); and second, by walking 1, 5 or 10 Kilometers, players can also hatch eggs containing random pocket monsters that have better biological properties than those caught on the wild. Mobile Communication Records. Telefónica has 1,464 cell phone towers in the municipalities under consideration. We studied an anonymized Call Detail Records (CDR) dataset from Telefónica Chile. This dataset contains records from seven days prior to the launch of Pokémon Go in 2016 (from July 27th to August 2nd) and seven days after (from August 4th to August 10th). We did not take into account the day of the o(cid:28)cial launch of Pokémon Go, as there was no speci(cid:27)c hour in which the game was o(cid:28)cially and generally available. Also note that the dataset contains pre-paid and contract subscriptions from Telefónica. The dataset contains data-type events rather than voice CDRs [6]. Unlike typical Call Detail Records for voice, each data event has only one assigned tower, as there is no need for a destination tower. Each event has a size attribute that indicates the number of KiB downloaded since the last registered event. 7 https://goo.gl/vStth8. 8 https://goo.gl/4QHtBQ 2 data and methods 5 Figure 1: Spatial distribution of the Telefónica cell towers (orange triangles) and Pokémon points of interests (purple dots) in Santiago. 2 data and methods 6 We did not analyze the records from the entire customer population in Santiago. Instead, we applied the following (cid:27)ltering procedure: (i) we (cid:27)ltered out those records that do not fall within the limits of the zones from the travel survey, and also those with a timestamp outside the range between 6:00 AM and 11:59 PM; (ii) to be considered, mobile devices must have been active every day under study, because a device that does not show regular events may belong to a tourist, someone who is not from the city, or does not evidence human-like mobility patterns such as points-of-sale (which are mostly static); (iii) only devices that downloaded more than 2.5 MiB and less than 500 MiB per day were included, as that indicates either inactivity or an unusual activity for a human (i. e., the device could be running an automated process); (iv) we used a Telefónica categorization scheme that associates an anonymized device ID with a certain category of service: for example pay-as-you-go, contractual, enterprise, etc. This gives us a good idea of the general kind of account holders. Thus, every step of this procedure was taken to ensure that events were triggered by humans. After applying these (cid:27)lters, the dataset comprised records from 142,988 devices. Our (cid:27)ltering procedure ensures that a positive di(cid:29)erence in the number of connections between two di(cid:29)erent days represents more people within a given zone. Depending on conditions such as time and location, we may interpret that some of those people are on the street. For instance, we may look at typical times where people commute, or at places where people are either inevitably outdoors (e. g., in a park) or inevitably at residential areas, which tend to have WiFi networks.9 Land Use Clusters. We may take each tra(cid:28)c analysis zone to belong to one category of land use: residential, business, and areas with mixed activities (e. g., business plus recreation or shopping activities, etc.). These categories are the result of our previous work on land use and CDR data, which is based on hierarchical clustering of time-series of connections at each zone of the city [9]. 2.2 Approach This study uses a natural experiment approach to measure the Pokémon Go e(cid:29)ect at the city scale. To do this, we analyzed the change in population patterns before and after the launch of Pokémon Go as evidenced by CDR data. First, we described a method of smoothing the number of connected devices at each cell tower according to several snapshots of the tower network. A snapshot is the status of the cell phone network in a given time-window [10]. Then, we aggregated these device counts at the zone level to de(cid:27)ne a set of observations that we evaluated in a regression model. We took into account covariates that enabled us to isolate and quantify the Pokémon Go e(cid:29)ect. Device counts at each tower and zone level aggregation. Let e ∈ E be a network event, and E is the total number of such events. A network event e is a tuple (d, u, b, z), where d is a timestamp with a granularity of one minute, u is some (anonymized) user id, b is a tower id, and z is one of the previously de(cid:27)ned geographical areas of Santiago. For each tower b and time d we developed a time-series Bd,b which represented the number of unique users from E connected to b at d. Due to the sparsity of CDR data, it is possible that B is not continuous. As consequence, the time-series could be null (B = 0) at a point of time where there were active devices at the corresponding tower. To account for this sparsity and obtain a continuous time-series, we smoothed each time-series B using Locally Weighted Scatterplot Smoothing (LOWESS) interpolation [11], obtaining B(cid:48) . To obtain a LOWESS curve, several non-parametric polynomial d,b regressions are performed in a moving window. The size of this window is the bandwith parameter for the model. In our implementation, this value is 30, which is interpreted as follows: each connection in(cid:30)uences (i. e., is counted into) its correspondent location during 30 minutes. Then, for each zone z, we aggregated 9 72% of homes have Internet access according to the last survey of telecommunication infrastructure by the Ministry of Telecom- munications of Chile, available at https://goo.gl/bwyzPG. 3 case study: the effect of pokØmon go in santiago, chile 7 into Sd,z by computing the sum of all time-series B(cid:48) d,bi all time-series B(cid:48) , where the tower bi lies in z d,bi (determined using a point-in-polygon test, as in [12]). Finally, each Sd,z time-series represents the (cid:30)oating population pro(cid:27)le for each zone under study. Measuring the Pokémon Go e(cid:29)ect. To measure the city-wide Pokémon Go e(cid:29)ect we considered the availability of the game as a city intervention, which started on the day of the launch of the game. Our hypothesis is that the following days would show an e(cid:29)ect of the game if people went out, regardless of being players or not, and this e(cid:29)ect would show on the number of people connected at each zone of the city. To do so, we used Negative Binomial Regression (NB) [13, 7] applied to our dataset at 1-minute intervals during a day. The NB regression model has been used frequently to analyze over-dispersed count data, i. e., when the variance is much larger than the mean, contrary to the Poisson model [14]. For every minute under study (note that we restricted ourselves from 6 AM until 12AM), we performed a NB regression using the observed device counts at each zone of the city in all available days in the dataset. The model is speci(cid:27)ed as follows: log E[X(t)] = log a + β0 + β1PoGo + β2DayO f Week + β3LandUse + β4PokePoints, where E[X(t)] is the expected value of the number of active devices within a zone at time t. The PoGo factor is a binary variable that has a value of 0 when the game was not available, and 1 when it was available. The covariates DayOfWeek (with values business_day, Saturday, and Sunday) and LandUse (with values residential, business_only, and mixed_activities) account for the (cid:30)uctuations in population on di(cid:29)erent days according to land use. Both factors use dummy coding because they are categorical. The covariate PokéPoints represents the number of PokéStops and PokéGyms, which are proxies for points of interest within an area, accounting for the number of potential attracting places in each zone. The exposure value a represents the surface area of each zone. Because urbanists designed each zone having into account population density, transportation infrastructure, and administrative boundaries, the exposure parameter also allowed to control indirectly for these potential covariates. The model output allows the following interpretation: the β coe(cid:28)cient assigned to each factor represents the di(cid:29)erence of the logarithm of expected counts in a zone at time t, if all other factors were held equal. Since β = log µ1 − log µ0 = log µ1 , then the di(cid:29)erence of logarithms equals the logarithm of the ratio between population counts before and after the availability of the game. The exponential of this coe(cid:28)cient is de(cid:27)ned as Incidence Rate Ratio, IRRβ(t) = eβ(t). We developed a time-series of IRRβ(t) values for each factor. By analyzing these time-series we determined when, in terms of time-windows within a day, there were signi(cid:27)cant e(cid:29)ects for each factor. µ0 3 case study: the effect of pokØmon go in santiago, chile Our aim was to measure the e(cid:29)ect of Pokémon Go in the number of people and their mobility patterns in a city. As stated in our methods section, the (cid:27)rst step is to obtain a smoothed number of connected devices to each tower per minute during the previous/following seven days to the launch of the game. Figure 2 (a) shows the normalized number of events per minute in a speci(cid:27)c tower (Moneda Metro Station) during July 27th. The chart shows that there are many minutes (dots) without registered events, i. e., their position in the y-axis is 0. This shows the sparsity of the data, because this tower is located in a business area with a high rate of public transportation tra(cid:28)c. We used LOWESS interpolation to be able to approximate the number of people even in those minutes where there are no events. The continuous lines in Figure 2 (a) are LOWESS interpolation calculations considering values of 10, 20, 30 and 40 minutes for the LOWESS time windows. After manual inspection of the dataset, we reasoned that a time window of 30 3 case study: the effect of pokØmon go in santiago, chile 8 Figure 2: Connected device counts at a speci(cid:27)c cell tower (a), and at a zone, aggregating several towers (b). Each dot represents the number of connections at a speci(cid:27)c time of the day. The curves represent LOWESS interpolation of the number of connected devices. 3 case study: the effect of pokØmon go in santiago, chile 9 minutes captured interesting regularities without incurring in noise produced by the sparsity of the data, nor smoothing the dataset too much. Figure 2 (b) shows the aggregation of towers within Zone 44 for three di(cid:29)erent days: a week before the launch of the game, the day of the launch, and a week after. Zone 44 contains a park (Parque O'Higgins), which is not usually visited at night, hinting that the availability of the game may have in(cid:30)uenced a di(cid:29)erent behavior. City-level connections. Figure 3 shows the city-level aggregated distributions of: (a) number of connected devices, and (b) downloaded information. Note that in both (cid:27)gures the distributions are normalized by dividing each value by the global maximum value. The (cid:27)gure considers three categories of days: before, during, and after the launch of Pokémon Go. In terms of connections, one can see that the patterns are stable across most days, with the total number of connections generally higher when Pokémon Go was available. This means, intuitively, that there were more people connected to the network presumably playing the game. Two rather surprising e(cid:29)ects are found on Mondays between 10 AM and 12 PM when Pokémon Go was available, and Tuesdays at about 12 PM when it was not yet available. In the (cid:27)rst case, we hypothesize that since it was the (cid:27)rst Monday after the launch of the game, people were trying it out. In the second case, there does not seem to be any explanation for the sudden drop of connections before the launch of the game, but it might be due to general network outages. Notice that the curve of Pokémon Go availability in the same time period behaves as expected. In terms of downloaded information, the patterns present smaller variations across days, and some of them present identical behavior. We cannot assume that more data implies people playing, due to how the game works: the user has to keep the screen active for the game, and most of the game data-transfers are text-encoded packages of information (e. g., position updates about nearby pocket monsters, in JSON format). Conversely, social media applications can use more data, due to the size of images, and the streaming of audio and video. Hence, we leave data-tra(cid:28)c analysis for future work. However, one e(cid:29)ect that is clear is how the game was massively downloaded on its launch, Wednesday, August 3rd. Note that a word should be said about Saturdays. The (cid:27)rst Saturday after the release of Pokémon Go exposes the highest number of device connections found in the dataset. While it is tempting to associate any found e(cid:29)ect to other extraneous factors (for example, the Olympic Games were on TV at the same time of our study), Figure 3 (b) shows that Saturdays exhibit similar behavior in terms of data consumption. Thus, it is unlikely that the Olympic Games were watched massively, at least not using mobile phones. Negative Binomial Regressions. After aggregating the smoothed counts for each zone, we performed a NB regression for every 1-minute snapshot across the days in our dataset. In other words, for each minute, the observations are the aggregated zone counts for all days, for all zones, at that speci(cid:27)c minute. As result, we obtained a time-series of regressions representing the dynamics of each factor in our model. Figure 4 shows the Incidence Rate Ratios (IRR) for each factor, as well as the distribution of model dispersion (α). An IRR of one means that the factor does not explain change. Although the signi(cid:27)cance of each factor is evaluated minute by minute applying a z-test, the visualization of each factor's IRR allows to visually determine signi(cid:27)cance if its 95% con(cid:27)dence intervals does not intercept y = 1. The day of week covariates captured behavior expected for weekends. There are fewer people (IRR is signi(cid:27)cantly lesser than 1) in the morning for both kinds of days. For instance, the Saturday factor captured a portion of the night e(cid:29)ect (its IRR at 9:59 PM is 1.278). This means that not all people who went out on the Saturday when the game was available can be explained by the Pokémon Go factor. The land use covariates captured the dynamics of high (cid:30)oating population during the day, given the bell-shape of their distributions, and their IRRs are signi(cid:27)cant during the whole day. The PokéPoints covariate, which is a proxy for points of interest in the city, is also signi(cid:27)cant during the whole day. Its maximum IRR is 1.019, 3 case study: the effect of pokØmon go in santiago, chile 10 Figure 3: LOWESS time-series of normalized number of connected devices (a) and normalized total down- loaded information (b), per minute, for all days in the dataset. The distributions are normalized by dividing the actual number of connections by the global maximum value. Each panel represents a di(cid:29)erent nominal day, with curves for a day before/after the launch of Pokémon Go. Wednesdays include an additional day that represents the launch of the game. 3 case study: the effect of pokØmon go in santiago, chile 11 Figure 4: Covariates and dispersion (α) for each factor of the Negative Binomial regression applied to the 1-minute snapshots. The Intercept factor includes the base values of each factor: 0 for the Pokémon Go factor, business_day for DayOfWeek, residential_area for LandUse, and 0 for the number of PokéPoints. 3 case study: the effect of pokØmon go in santiago, chile 12 Table 1: Time-windows where the Pokémon Go e(cid:29)ect was signi(cid:27)cant. Each window includes its maximum Incidence Rate Ratio (IRR) and its corresponding time of the day. Time of Max IRR Time Window Max IRR 6:34 – 6:47 7:07 – 7:18 7:37 – 7:46 7:48 – 7:48 9:35 – 9:43 10:27 – 10:41 10:53 – 11:18 11:58 – 12:46 13:06 – 13:09 15:36 – 15:51 16:17 – 16:21 18:30 – 18:34 19:42 – 19:45 21:24 – 22:12 22:22 – 22:25 22:44 – 22:52 23:09 – 23:21 23:57 – 23:59 1.062 1.056 1.054 1.047 1.060 1.077 1.071 1.138 1.051 1.058 1.052 1.052 1.051 1.096 0.955 0.954 0.954 1.057 6:40 7:11 7:42 7:48 9:40 10:34 11:07 12:31 13:08 15:50 16:19 18:31 19:43 21:38 22:25 22:52 23:09 23:59 which means that for every additional POI in a zone, the number of people increases by 1.9%, if all other factors are held equal when performing the comparison. We then analyzed the time windows when the Pokémon e(cid:29)ect is signi(cid:27)cant. Table 1 summarizes these time windows, most of which are a few minutes long. However, there are two windows with prominent lengths: from 11:58 AM to 12:46 PM, and from 9:24 PM to 10:12 PM. These time windows also contain the highest Pokémon Go IRR values found per window: 1.138 and 1.096, respectively. Thus, all other factors being held equal, the availability of the game increased the number of people connected to mobile towers in the city by 13.8% at lunch time and 9.6% at night. Finally, notice that we also tested for statistical interactions between the regression factors, but they were not signi(cid:27)cant. Additionally, we tested the model without the covariates, having only the intercept and the Pokémon e(cid:29)ect. Particularly, the greater time-windows presented similar results and lengths, indicating that the model is robust. Explaining the Pokémon Go E(cid:29)ect. Given the speci(cid:27)cation of our model, our results are city-wide. To explore results at a (cid:27)ner geographical level, we estimated the di(cid:29)erence between two time-series: the mean of connection counts per zone after and before the launch of the game by separating observations between business days and weekends. Then, we adjusted the time-series according to the surface area of each zone, and we obtained time-series per zone that indicate whether they had, on average, more or fewer people connected after the launch of the game. To (cid:27)nd whether these di(cid:29)erences correlate with the number of PokéPoints per square kilometers in each zone, we performed a Pearson correlation for all the minutes of the day with maximum IRR values (see Table 1). These correlations vary during the day, as shown on Figure 5. For business days, the highest correlation was found at 12:31 (r = 0.59, p < 0.001). For weekends, the highest correlation was found at 21:38 (r = 0.44, p < 0.001). The e(cid:29)ect is stronger at lunch time on business days, and at night on weekends. Figure 6 displays four choropleth maps of Santiago. The top row contains two maps, both showcasing di(cid:29)erences per zone at 12:31 PM. The left map (a) displays business days, and the right (b) displays weekends. 4 discussion 13 Figure 5: Pearson correlation coe(cid:28)cients for business days and weekends. The correlation estimates the relation between the number of PokéPoints in a given area, and the number of connections within it. These coe(cid:28)cients are proxies for how much attraction was generated from areas with many points of interest. Similarly, the bottom row displays di(cid:29)erences at 21:38 (business days at (c), weekends at (d)). Regarding the correlations described in Figure 5, one can see that Fig. 6 (a) shows a highly concentrated e(cid:29)ect in the city historical center. Reportedly, players visited this place at all times of the day, both because of its location within the city, as well as the availability of PokéPoints.10 In contrast, weekends present a more diversi(cid:27)ed e(cid:29)ect on the city, specially at night, with many areas showing highly positive di(cid:29)erences. A careful exploration of the map (d) reveals that zones with higher di(cid:29)erences contain or are near parks and public plazas. We also compared how the Pokémon Go e(cid:29)ect related to urban mobility, by graphically comparing the signi(cid:27)cant time-windows with the trip density distribution from the travel survey. Figure 7A shows the position of each time-window as a bar, and the trip densities as lines for business days, Saturdays, and Sundays. In the morning, the signi(cid:27)cant time-windows appear when the trip density is increasing or when it reaches a local maxima in business days. They also appear after noon, potentially linked to lunch breaks during business hours. All other e(cid:29)ects, such as those at night, do not appear to have any correlation with trip behavior. Given that the travel survey is already about (cid:27)ve years old, it was also important to compare our results to current trip distributions. We applied a work-in-progress algorithm, based on previous work on inferring trips from CDR data [15]. Figure 7B shows that, in general terms, trip distributions and the e(cid:29)ects still hold for CDR detected trips. This is not surprising, given how hard it is to change a whole population's general mobility patterns without any exogenous circumstances, at least at the 5-year scale. In any case, this lends further validation to our main results. 4 discussion We performed a natural experiment at the city-scale comparing the behavior of a subset of the population before and after the launch of Pokémon Go in Santiago. We found that the availability of the game increased the number of people that connected to the Internet on their mobile phones by 13.8% at lunch time and 9.6% at night. A further exploration of the relationships among urban mobility patterns, mobile connectivity 10 https://goo.gl/RcxkVA 4 discussion 14 Figure 6: Choropleth maps of the di(cid:29)erence between the means of connected devices per zone, before and after the launch of of Pokémon Go. Top row shows di(cid:29)erences at 12:31 PM on business days (a) and weekends (b). Bottom row shows di(cid:29)erences at 9:38 PM on business days (c) and weekends (d). The di(cid:29)erences are adjusted by zone area, and consider business and weekend days as di(cid:29)erent groups. A zone with a value of 0 did not show di(cid:29)erences between periods. 4 discussion 15 Figure 7: Distribution of trip start time according to: (a) the travel survey held in Santiago in 2012, and (b) detected trips during the Pokémon days. The trips are aggregated into business days, Saturdays, and Sundays. Each rectangle shows the time-window in which the Pokémon Go e(cid:29)ect is signi(cid:27)cant in the regression models. and points of interests revealed that there are two primary ways in which the Pokémon e(cid:29)ect is noticeable. On the one hand, people take advantage of commuting times and breaks during the day to play the game. Thus, players tend to be near their work/study places, which are mostly downtown. On the other hand, on weekends at night the e(cid:29)ect is more diversi(cid:27)ed, implying that people tend to play the game in places near their homes. In his book "The Great Good Place", Ray Oldenburg discussed the need for third places in the city: "In order for the city and its neighborhoods to o(cid:29)er the rich and varied association that is their promise and potential, there must be neutral ground upon which people may gather. There must be places where individuals may come and go as they please, in which no one is required to play host, and in which we all feel at home and comfortable" [16]. The concept comes from the designation of home and work (or study) as (cid:27)rst and second places in one's life. Nowadays, third places are facing two challenges. First, virtual worlds [17] and social networks [18] provide social infrastructure that is similar to that of third places, but without going out of the (cid:27)rst or second place. Second, perceptions of crime and violence are making the city feel less safe than it really is. In Santiago, this has been called fear of life [19]. Hence, the usage of location-based augmented reality games may help to alleviate both situations, by placing virtual worlds on top of physical reality, and by motivating people to go out and walk around their neighborhoods as our results indicate. Because Pokémon Go has the e(cid:29)ect of increasing the number of pedestrians on the street, it has the potential to convert the city into a third place given its social features. Motivating the presence of pedestrians is important and relates to a theory put forth by Jane Jacobs, who claims that there are four conditions that must be met for a city to be lively and safe. These conditions are: the presence of pedestrians at di(cid:29)erent times of the day, the availability of mixed uses in districts, the mixture of old and new buildings, and the availability of many crossings for pedestrians [20]. Even though testing theories like these is di(cid:28)cult, some work has already been done. For instance, the city of Seoul found some evidence in favor of the theory by using house-hold surveys [21]. Recently, mobile communication records have been used to validate Jacobs' theories in Italian cities [22]. Studies like those mentioned above [21, 22] perform an ex-post analysis of whether lively places comply with theories. A more granular approach would be to perform natural experiments like ours. To the extent of our knowledge, this is the (cid:27)rst experiment of its kind performed using mobile records of data-type. Our method makes it possible to measure the e(cid:29)ect not only of long-term 4 discussion 16 but also short-term interventions, opening a path to quantify how much speci(cid:27)c actions help improve quality of life in the city. For instance, crime-data could be correlated with results obtained with our method to test whether the safety and livelihood theories hold after speci(cid:27)c interventions. Additionally, as our (cid:27)gures have shown (cf. Fig. 6), our method is able to produce maps apt for patch dynamics visualization to monitor population density [23]. Limitations. One limitation in our study is the lack of application usage identi(cid:27)cation. Thus, even though we included several covariates in our model to account for other e(cid:29)ects, we may still be confounding other e(cid:29)ects outside the Pokémon Go factor. Another possible confounding variable is the presence of events that may attract lots of people at certain hours, in(cid:30)uencing the Pokémon e(cid:29)ect. In particular, since popular events such as important football games or cultural presentations were being held in Santiago at the same time as Pokémon go was launched, we felt the need to test for an e(cid:29)ect. Adding those events as a new land use category at the zone and the time when the popular events were held, we found that they only account for the 0.01 percent of observations. Therefore, popular events had either negligible e(cid:29)ects or no e(cid:29)ect at all in our study. While it can be argued that most of the Pokémon Go media appearances focus on speci(cid:27)c situations, like those related to museums, tourism, and physical activity of some players, our empirical results uncovered to which extent the availability of the game is related to the number of people on the street. Even though mobile phone datasets are usually not public, it is becoming more common to have access to this kind of information thanks to several initiatives in opening and sharing data [6]. This kind of analysis is almost costless to perform by telecommunications companies, because mobile records are already extracted and stored for billing purposes. A further issue involves the nature of the dataset itself. As we mentioned in the paper, Telefónica Movistar has a little more than a third of the Chilean mobile marketshare. This is the largest portion of the market (the other 60% is owned by many other smaller companies, with the second largest one at 20%). This does, however, introduce some data biases, although they are hard to identify and quantify. One such bias is population bias: it is not the case that Telefónica customers are distributed uniformly in the geographical space under study. Since we do not have access to the Telefónica database of customers, we cannot tell how representative a certain cell-phone tower is to Telefónica versus other telcos. A (cid:27)nal note of caution could be said about weekend e(cid:29)ects: since we only have one weekend, we cannot be completely con(cid:27)dent about the results. Unfortunately, this is the dataset we have. In any case, our study was meant to be at "city" level, and only analyzed the di(cid:29)erent days to explore the nature of the e(cid:29)ect. Regarding a potential novelty e(cid:29)ect in our results, it may be the case that not all Pokémon Go players during the (cid:27)rst few days were still engaged with the game later. Indeed, the number of Pokémon Go players has gone down enormously. While the novelty e(cid:29)ect might be true, our study was not aimed at evaluating the popularity of the game. Instead, its purpose was to quantify the city-level e(cid:29)ects, something that could have been more concentrated in time: in Chile, the game was highly anticipated by the users and the media, because it was released almost one month later than in the USA. Future Work. User modeling and classi(cid:27)cation may help to categorize users into Pokémon players and non-players, in order to study the individual e(cid:29)ects of the game. This can be done, for instance, by estimating their daily routines from their CDR-based trajectories [24, 15], as well as their home and work locations [9]. Using these methodologies, we could learn whether they visited unknown places, or whether they walked slowly or faster. An epidemiological analysis of player behavior [25] could help evaluate whether social interactions in(cid:30)uence city exploration as a result of the Team Battle Dynamics featured in the game. A study of whether the use of the game is correlated with crime-rate reduction in public places, which could 5 related work 17 be linked with urban theories about street safety and could be useful for urban planners or the police, as well as providing evidence to some of Jacob's theories. Finally, given the dataset we had available, we measured the immediate change in mobility patterns for the whole city of Santiago. However, it would have been very interesting to show that the changes in behavioral patterns hold for some weeks further into the future, perhaps even when the popularity of the game was declining (see the provisos above). This could have been a very interesting result that may have opened possible innovative usages of game-based strategies of this kind to modify citizens' behavioral routines. 5 related work Mobile Phone Data Analysis. Our work builds on the extensive literature on the analysis of mobile records. We refer the reader to comprehensive surveys of research in this wide area [26, 27]. Here, we focus on describing the speci(cid:27)c topics that intersect with our research. In order to analyze our data, we borrowed the concept of a "snapshot," i. e., the status of the cell phone network during a speci(cid:27)c interval of time [10]. The comparison of snapshots of the network enables us to (cid:27)nd which time instants actually show interesting, and, in our case, statistically signi(cid:27)cant di(cid:29)erences. In contrast, previous work has focused mostly on studying the network when it showed higher tra(cid:28)c volume or population density [28], without controlling for covariates or population size, which we do in this work. Controlling for this was achieved by (cid:27)xing the number of users to only those active every single day under study, minimizing "noise" in the form of one-o(cid:29) users, for instance. We also make use of the concept of (cid:30)oating population pro(cid:27)le derived from our own, and other similar work [9, 29, 30, 31, 32, 33]. An interesting result is that research based on this methodology has proven consistent across di(cid:29)erent cities, enabling urban planners to compare cities with respect to their land use patterns [32], as well as to study how rhythms of life di(cid:29)er according to socio-cultural factors [34]. According to a recent survey of urban sensing research [6], local event analysis is a key area of mobile phone data analysis. Local events are usually de(cid:27)ned as unusual gatherings or movements of massive amounts of people (e. g., protests, emergencies, sports, natural events, etc.) [35, 36, 37, 38]. Hence, the unit of analysis is a single event with time and space constraints. Our method, instead, works at the city level with less prescribed time and location from those above. One thing in common between our work and the cited references is that all analysis have been performed ex-post, which makes it possible to create spatio-temporal signatures of places [29]. Even though these approaches allow us to analyze and understand the city, they do not allow measurement of city-scale phenomena due to their assumptions of locality. Another relevant area is prediction and forecasting of human mobility [39, 40, 41, 42], which allow to understand distributions [42] and limits of predictability in human mobility [41]. Those methods focus on the big picture of mobility and rely on probabilistic models that need extensive datasets covering large periods of time, unlike ours, which only analyzed a two-week period. Another approach uses regression [40], as we do. However, our method di(cid:29)ers: instead of using longitudinal data in only one regression model, for which Poisson models are better suited [40, 14], we use many consecutive Negative Binomial models, one for each time snapshot of the network, thus avoiding violating the assumptions of the Poisson model, and controlling for daily rhythms at the same time [43]. As the dispersion value showcases (cf. Figure 4), the NB regression was a correct choice, due to the exposure α being greater than zero [44]. In our case, factors that could have caused over-dispersion include aggregation and non-uniform spatial distribution of the units of analysis [45]. 6 conclusions 18 Augmented Reality and Location-based Games. The e(cid:29)ects of augmented reality games and appli- cations within the city have been anticipated for more than one decade [46, 47]. However, the limits in mainstream hardware have impeded their general implementation/adoption at di(cid:29)erent times. Most studies about the impact of those games have been small-scale only [48]. Even though smartphone technology has allowed location-based augmented reality games to become more commonplace in the last few years, until the launch of Pokémon Go, they still lacked the cultural impact needed to have a considerable e(cid:29)ect on the city. As Frank Lantz is quoted in [49], in relation to the game PacManhattan: "If you want to make games like this you have to work hard to recruit an audience for them, you can't just make up something awesome and then hope that people fall into it" [50]. Since as we discussed above, Pokémon is one of the most successful media franchises in the world [5], it enables the unique opportunity to study both, the impact of a location-based augmented reality game; and the e(cid:29)ect of an intervention at the city scale when it comes to population mobility. 6 conclusions In this paper, we studied how Pokémon Go a(cid:29)ected the (cid:30)oating population patterns of a city. The game led to notable pedestrian phenomena in many parts of the world. This is extraordinary in the sense that it happened without the usual triggers like war, climate change, famine, violence, or natural catastrophes. In this regard, to the extent of our knowledge, this is the (cid:27)rst large-scale study on the e(cid:29)ect of augmented reality games on city-level urban mobility. Given the massive popularity of the Pokémon brand, and its cultural impact in many parts of the world, we believe that the found e(cid:29)ects represent a good approximation of mobility change in a large city. Jane Jacobs theorized that the streets need more pedestrians to be safe and lively [20]. Using CDR data, it has been shown that this is true in at least some cities [22]. Thus, one of the most important conclusion of our work is that cities may not need to change their infrastructure in the short term to motivate pedestrians to go out. A game about imaginary creatures lurking in neighborhoods, that can be collected using cell phones encourage people to go out and make streets more lively and safe when they are commuting, or when they have free time during lunch or at night. In summary, this study identi(cid:27)ed and investigated the e(cid:29)ect of a speci(cid:27)c type of phenomenon in the pulse of a city, measured through its (cid:30)oating population mobility patterns and usage of Pokémon Go. Our methods can be used to perform other natural experiments related to urban mobility, enabling measurement of the impact of city-wide interventions, and using the results to inform public policy changes. funding The authors would like to thank Movistar - Telefónica Chile and the Chilean government initiative CORFO 13CEE2-21592 (2013-21592-1-INNOVA_PRODUCCION2013-21592-1) for (cid:27)nantial support of this paper. competing interests The authors declare that they have no competing (cid:27)nantial interests. References 19 acknowledgements We thank Alonso Astroza for providing a crowdsourced list of Ingress Portals validated as Pokémon Go PokéStops and PokéGyms. The analysis was performed using Jupyter Notebooks [51], jointly with the statsmodels [52] and pandas [53] libraries. All the maps on this paper include data from ©OpenStreetMap contributors and tiles from ©CartoDB. We also thank Telefónica R&D in Santiago for facilitating the data for this study, in particular Pablo García Briosso. Finally, we thank the anonymous reviewers for the insightful comments that helped to improve this paper. author contributions EG and LF designed the experiment. EG, LF and DC performed data analysis. All authors participated in manuscript preparation. availability of data and materials The Telefónica Movistar mobile phone records have been obtained directly from the mobile phone operator through an agreement between the Data Science Institute and Telefónica R&D. This mobile phone oper- ator retains ownership of these data and imposes standard provisions to their sharing and access which guarantee privacy. Anonymized datasets are available from Telefónica R&D Chile (http://www.tidchile.cl) for researchers who meet the criteria for access to con(cid:27)dential data. Other datasets used in this study are either derived from mobile records, or publicly available. references [1] Majorek, M., du Vall, M.: Ingress an example of a new dimension in entertainment. Games and Culture 11(7-8), 667–689 (2015) [2] Moore, K.: Painting the town blue and green: Curating street art through urban mobile gaming. M/C Journal 18(4) (2015) [3] Stark, E.: Playful places: uncovering hidden heritage with ingress. Social, Casual and Mobile Games: The Changing Gaming Landscape, 149 (2016) [4] Papandrea, M., Zignani, M., Gaito, S., Giordano, S., Rossi, G.P.: How many places do you visit a day? In: Pervasive Computing and Communications Workshops (PERCOM Workshops), 2013 IEEE International Conference On, pp. 218–223 (2013). IEEE [5] Buckingham, D., Sefton-Green, J., Allison, A., Iwabuchi, K., Tobin, J.: Pikachu's Global Adventure: The Rise and Fall of Pokémon. Duke University Press, Durham, NC, United States (2004) [6] Calabrese, F., Ferrari, L., Blondel, V.D.: Urban sensing using mobile phone network data: a survey of research. ACM Computing Surveys (CSUR) 47(2), 25 (2015) [7] Greene, W.: Functional forms for the negative binomial model for count data. Economics Letters 99(3), 585–590 (2008) References 20 [8] Puertas, O.L., Henríquez, C., Meza, F.J.: Assessing spatial dynamics of urban growth using an integrated land use model. Application in Santiago Metropolitan area, 2010–2045. Land Use Policy 38, 415–425 (2014) [9] Graells-Garrido, E., Peredo, O., García, J.: Sensing urban patterns with antenna mappings: the case of Santiago, Chile. Sensors 16(7), 1098 (2016) [10] Naboulsi, D., Stanica, R., Fiore, M.: Classifying call pro(cid:27)les in large-scale mobile tra(cid:28)c datasets. In: IEEE INFOCOM 2014-IEEE Conference on Computer Communications, pp. 1806–1814 (2014). IEEE [11] Cleveland, W.S., Devlin, S.J.: Locally weighted regression: an approach to regression analysis by local (cid:27)tting. Journal of the American Statistical Association 83(403), 596–610 (1988) [12] Mao, H., Shuai, X., Ahn, Y.-Y., Bollen, J.: Quantifying socio-economic indicators in developing countries from mobile phone communication data: applications to Côte d'Ivoire. EPJ Data Science 4(1), 1–16 (2015) [13] Nelder, J.A., Baker, R.J.: Generalized linear models. Encyclopedia of statistical sciences (1972) [14] Cameron, A.C., Trivedi, P.K.: Regression Analysis of Count Data vol. 53. Cambridge University Press, Cambridge, MA, United States (2013) [15] Graells-Garrido, E., Saez-Trumper, D.: A day of your days: estimating individual daily journeys using mobile data to understand urban (cid:30)ow. In: Proceedings of the Second International Conference on IoT in Urban Space. Urb-IoT '16, pp. 1–7. ACM, New York, NY, USA (2016) [16] Oldenburg, R.: The Great Good Place: Cafes, Co(cid:29)ee Shops, Community Centers, Beauty Parlors, General Stores, Bars, Hangouts, and How They Get You Through the Day. Paragon House, New York (1989) [17] Steinkuehler, C.A., Williams, D.: Where everybody knows your (screen) name: Online games as "third places". Journal of Computer-Mediated Communication 11(4), 885–909 (2006) [18] Rao, V.: Facebook applications and playful mood: the construction of facebook as a third place. In: Proceedings of the 12th International Conference on Entertainment and Media in the Ubiquitous Era, pp. 8–12 (2008). ACM [19] Dammert, L., Malone, M.F.T.: Fear of crime or fear of life? public insecurities in Chile. Bulletin of Latin American Research 22(1), 79–101 (2003) [20] Jacobs, J.: The Death and Life of Great American Cities. Vintage Books, New York, United States (1961) [21] Sung, H., Lee, S., Cheon, S.: Operationalizing Jane Jacobs's urban design theory empirical veri(cid:27)cation from the Great City of Seoul, Korea. Journal of Planning Education and Research, 0739456–14568021 (2015) [22] De Nadai, M., Staiano, J., Larcher, R., Sebe, N., Quercia, D., Lepri, B.: The death and life of great Italian cities: a mobile phone data perspective. In: Proceedings of the 25th International Conference on World Wide Web, pp. 413–423 (2016). International World Wide Web Conferences Steering Committee References 21 [23] Pulselli, R., Ramono, P., Ratti, C., Tiezzi, E.: Computing urban mobile landscapes through monitoring population density based on cellphone chatting. Int. J. of Design and Nature and Ecodynamics 3(2), 121–134 (2008) [24] Calabrese, F., Di Lorenzo, G., Liu, L., Ratti, C.: Estimating origin-destination (cid:30)ows using mobile phone location data. IEEE Pervasive Computing 10(4), 0036–44 (2011) [25] Kulldor(cid:29), M.: Statistical methods for spatial epidemiology: tests for randomness. GIS and Health, 49–62 (1998) [26] Blondel, V.D., Decuyper, A., Krings, G.: A survey of results on mobile phone datasets analysis. EPJ Data Science 4(1), 1 (2015) [27] Barlacchi, G., De Nadai, M., Larcher, R., Casella, A., Chitic, C., Torrisi, G., Antonelli, F., Vespignani, A., Pentland, A., Lepri, B.: A multi-source dataset of urban life in the city of Milan and the Province of Trentino. Scienti(cid:27)c data 2 (2015) [28] Deville, P., Linard, C., Martin, S., Gilbert, M., Stevens, F.R., Gaughan, A.E., Blondel, V.D., Tatem, A.J.: Dynamic population mapping using mobile phone data. Proceedings of the National Academy of Sciences 111(45), 15888–15893 (2014) [29] Reades, J., Calabrese, F., Ratti, C.: Eigenplaces: analysing cities using the space–time structure of the mobile phone network. Environment and Planning B: Planning and Design 36(5), 824–836 (2009) [30] Soto, V., Frías-Martínez, E.: Automated land use identi(cid:27)cation using cell-phone records. In: Proceedings of the 3rd ACM International Workshop on MobiArch, pp. 17–22 (2011). ACM [31] Noulas, A., Mascolo, C.: Exploiting foursquare and cellular data to infer user activity in urban environments. In: Mobile Data Management (MDM), 2013 IEEE 14th International Conference On, vol. 1, pp. 167–176 (2013). IEEE [32] Lenormand, M., Picornell, M., Cantú-Ros, O.G., Louail, T., Herranz, R., Barthelemy, M., Frías-Martínez, E., San Miguel, M., Ramasco, J.J.: Comparing and modelling land use organization in cities. Royal Society Open Science 2(12), 150449 (2015) [33] Toole, J.L., Ulm, M., González, M.C., Bauer, D.: Inferring land use from mobile phone activity. In: Proceedings of the ACM SIGKDD International Workshop on Urban Computing, pp. 1–8 (2012). ACM [34] Ahas, R., Aasa, A., Silm, S., Tiru, M.: Daily rhythms of suburban commuters' movements in the Tallinn metropolitan area: case study with mobile positioning data. Transportation Research Part C: Emerging Technologies 18(1), 45–54 (2010) [35] Calabrese, F., Pereira, F.C., Di Lorenzo, G., Liu, L., Ratti, C.: The geography of taste: analyzing cell- phone mobility and social events. In: International Conference on Pervasive Computing, pp. 22–37 (2010). Springer [36] Ferrari, L., Mamei, M., Colonna, M.: People get together on special events: Discovering happenings in the city via cell network analysis. In: Pervasive Computing and Communications Workshops (PERCOM Workshops), 2012 IEEE International Conference On, pp. 223–228 (2012). IEEE References 22 [37] Traag, V.A., Browet, A., Calabrese, F., Morlot, F.: Social event detection in massive mobile phone data using probabilistic location inference. In: Privacy, Security, Risk and Trust (PASSAT) and 2011 IEEE Third Inernational Conference on Social Computing (SocialCom), 2011 IEEE Third International Conference On, pp. 625–628 (2011). IEEE [38] Bagrow, J.P., Wang, D., Barabasi, A.-L.: Collective response of human populations to large-scale emergencies. PloS one 6(3), 17680 (2011) [39] Calabrese, F., Di Lorenzo, G., Ratti, C.: Human mobility prediction based on individual and collective geographical preferences. In: Intelligent Transportation Systems (ITSC), 2010 13th International IEEE Conference On, pp. 312–317 (2010). IEEE [40] Shimosaka, M., Maeda, K., Tsukiji, T., Tsubouchi, K.: Forecasting urban dynamics with mobility logs by bilinear Poisson regression. In: Proceedings of the 2015 ACM International Joint Conference on Pervasive and Ubiquitous Computing, pp. 535–546 (2015). ACM [41] Song, C., Qu, Z., Blumm, N., Barabási, A.-L.: Limits of predictability in human mobility. Science 327(5968), 1018–1021 (2010) [42] Gonzalez, M.C., Hidalgo, C.A., Barabasi, A.-L.: Understanding individual human mobility patterns. Nature 453(7196), 779–782 (2008). doi:10.1038/nature06958 [43] Sevtsuk, A., Ratti, C.: Does urban mobility have a daily routine? Learning from the aggregate data of mobile networks. Journal of Urban Technology 17(1), 41–60 (2010) [44] Chan, A.B., Vasconcelos, N.: Bayesian Poisson regression for crowd counting. In: 2009 IEEE 12th International Conference on Computer Vision, pp. 545–551 (2009). IEEE [45] Lindén, A., Mäntyniemi, S.: Using the negative binomial distribution to model overdispersion in ecological count data. Ecology 92(7), 1414–1421 (2011) [46] Flintham, M., Benford, S., Anastasi, R., Hemmings, T., Crabtree, A., Greenhalgh, C., Tandavanitj, N., Adams, M., Row-Farr, J.: Where on-line meets on the streets: experiences with mobile mixed reality games. In: Proceedings of the SIGCHI Conference on Human Factors in Computing Systems, pp. 569–576 (2003). ACM [47] Magerkurth, C., Cheok, A.D., Mandryk, R.L., Nilsen, T.: Pervasive games: bringing computer enter- tainment back to the real world. Computers in Entertainment (CIE) 3(3), 4–4 (2005) [48] Kosoris, N., Chastine, J.: A study of the correlations between augmented reality and its ability to in(cid:30)uence user behavior. In: Computer Games: AI, Animation, Mobile, Multimedia, Educational and Serious Games (CGAMES), 2015, pp. 113–118 (2015). IEEE [49] Apperley, T., Leorke, D.: From the cybercafé to the street: The right to play in the city. First Monday 18(11) (2013) [50] Lantz, F.: Pacmanhattan. Space Time Play, 262–263 (2007) [51] Pérez, F., Granger, B.E.: IPython: a system for interactive scienti(cid:27)c computing. Computing in Science & Engineering 9(3), 21–29 (2007) [52] Seabold, S., Perktold, J.: Statsmodels: Econometric and statistical modeling with Python. In: Proceed- ings of the 9th Python in Science Conference, pp. 57–61 (2010) [53] McKinney, W.: Data structures for statistical computing in Python. In: Proceedings of the 9th Python in Science Conference, vol. 445, pp. 51–56 (2010) References 23
1604.06634
2
1604
2016-06-28T16:19:08
Forman-Ricci flow for change detection in large dynamic data sets
[ "cs.SI", "math.CO" ]
We present a viable solution to the challenging question of change detection in complex networks inferred from large dynamic data sets. Building on Forman's discretization of the classical notion of Ricci curvature, we introduce a novel geometric method to characterize different types of real-world networks with an emphasis on peer-to-peer networks. Furthermore we adapt the classical Ricci flow that already proved to be a powerful tool in image processing and graphics, to the case of undirected and weighted networks. The application of the proposed method on peer-to-peer networks yields insights into topological properties and the structure of their underlying data.
cs.SI
cs
Forman-Ricci flow for change detection in large dynamic data sets Melanie Weber1, Jurgen Jost 1,2 and Emil Saucan1,3 1Max-Planck-Institute for Mathematics in the Sciences; Inselstrasse 22, 04103 Leipzig, Germany 2 Santa Fe Institute; 1399 Hyde Park Road Santa Fe, New Mexico 87501 USA 3 Technion - Israel Institute of Technology; Haifa 32000, Israel (Contact: [email protected], [email protected], [email protected] ) June 29, 2016 Abstract We present a viable geometric solution for the detection of dynamic effects in complex networks. Building on Forman's discretization of the classical notion of Ricci curvature, we introduce a novel geometric method to characterize different types of real-world networks with an emphasis on peer- to-peer networks. We study the classical Ricci-flow in a network-theoretic setting and introduce an analytic tool for characterizing dynamic effects. The formalism suggests a novel computational method for change detection and the identification of fast evolving network regions and yields insights into topological properties and the structure of the underlying data. 1 Introduction Complex networks are by now ubiquitous, both in every day life and as mathematical models for a wide range of phenomena [1, 3, 4, 41] with applications in such diverse fields as Biology [5, 33], transportation and urban planning, [3, 6, 40], social networks like Facebook and Twitter [13], and – in its relevance dating back to early work on networks – in communication and computer systems [4]. The later belong to the class of peer-to-peer networks whose structure is characterized information transfer between the "peers". With novel geometric methods we attempt to analyze the structural properties and dynamics of real-world networks, focusing on peer-to-peer networks as an examplary use case. While the main corpus of theoretical research in the analysis of networks and related structures has been focused on the properties of the various (discrete) Laplacians (see [2] for an overview on the state of the art), a more recent – and, as we shall note below – related direction concerns the geometrical characterization of real-world and model type networks, see [21, 28, 34, 43]. Given that in geometry, curvature (intuitively, a measure quantifying the deviation of a geometrical object from being flat) plays a central role, the drive for finding various discrete, expressive notions of curvature capable of describing the structure of networks is most natural [4, 12, 41]. More recent "geometric" approaches consider discrete definitions of curvature as in [26, 37, 39, 43]. While somewhat esoteric for the "layman", Ricci curvature plays a central role in Riemannian Geome- try and has recently proven to be a remarkably powerful tool, mainly given its role in the celebrated proof by G. Perelman of Poincare's Geometerization Conjecture [31,32], following a path laid down earlier by R. Hamilton [18]. Moreover, Ricci curvature proved itself to be unexpectedly flexible and adaptable to var- ious discrete and more general settings, mainly in the version introduced by Y. Ollivier [28–30]. Various theoretical and practical applications have been explored in the literature, see respectively [7,21,27,34,35]. Despite its practicability in theoretical settings, the Ollivier-Ricci curvature is limited in its applici- bility on large, real-world networks. A major constraint is the high computational cost of its calculation. The Ollivier-Ricci curvature necessitates the calculation of the so called earth mover's distance 1, which in turn requires solving a non-trivial linear programming problem, thus rendering the computation un- feasible for trully large scale networks. A further limitation comes as a direct consequence of the very definition of Ollivier's concept: Given that the curvature's definition is instrinsically based on Optimal Transportation Theory, it follows that it is excellently suited for the investigation of information trans- fer in communication networks, yet it is less expressive as a model for structurally different types of interaction networks as occuring in biology or social sciences. 1a.k.a. the Wasserstein 1-metric 1 However, there is an alternative notion of discrete Ricci curvature that is computationally by far simpler and equally suited to describe the above discussed complex systems. The definition, introduced by Forman in [17], applies to a very generalized class of cellular structures that includes triangular and polygonal meshes, as well as graphs (and therefore networks). Therefore, the Forman-Ricci is a natural candidate for a discrete Ricci curvature that can be universally adapted to any type of network. After emerging as highly suited for rendering images [9–11] and complex network analysis [14], we will explore its applicibility on characterizing dynamic effects in complex systems. In the present article we continue and expand the programm initiated partly by [14], namely examining the relation of Forman-Ricci curvature with other geometric network properties, such as the node degree distribution and the connectivity structure. Based on this analysis, we suggest characterization schemes that yield insights in the dynamic structure of the underlying data as described in the following section. The emphasis of the article lies on analyzing the class of peer-to-peer networks, of which we provide two examples: Email communications [22] and information exchange with the file-exchange system Gnutella [19, 24]. The main part of the paper introduces a novel change detection method for complex dynamic networks that exploits the Ricci flow on the edges with respect to the Forman curvature. Efficient implementations of the formalism enable structural analysis of big data as we demonstrate with the Gnutella example. For this, we walk the reader through the analysis of sets of peer-to-peer network with respect to change detection, providing an overview on the work flow of the method. Future applications include the characterization of dynamic effects in various classes of real-world networks and the analysis of the underlying data, as well as curating of related data bases. 2 Methods The change detection method introduced in this article is based on a network-analytic formulation of the Ricci-flow using a discrete Ricci-curvature on networks introduced by R. Forman [17]. In this section we define both the Forman-Ricci-curvature and the Ricci-flow on networks and demonstrate their ability to characterize complex dynamic systems and their underlying data on the example of a peer-to-peer network. 2.1 Forman-Ricci curvature on networks In the classical context of smooth Riemannian manifolds (e.g. surfaces), Ricci curvature represents an important geometric invariant that measures the deviation of the manifold from being locally Euclidean by quantifying its volume growth rate. An essential property of this curvature is that it operates directionally along vectors. For our discrete setting it follows directly that Forman's curvature is associated with the discrete analog of those vectors, namely the edges of the network. While, as mentioned above, Forman's approach defines Ricci curvature on the very general setting of n- dimensional cellular structures, we will concentrate on the simpler case of 1-dimensional weighted cellular spaces that can be represented as a weighted network graph. We will not consider higher dimensional cases here, since their technicalities would carry us well beyond the scope of the present paper and our intended applications. For a theoretical introduction see [17]. In the 1-dimensional case, Forman's Ricci curvature for a network edge is defined by the following combinatorical formula  ω(v1) ω(e) + ω(v2) ω(e) (cid:34) − (cid:88) ω(ev1 )∼e,ev2∼e (cid:112)ω(e)ω(ev1 ) ω(v1) (cid:112)ω(e)ω(ev2 ) ω(v2) + (cid:35) RicF(e) = ω(e) (1) where • e denotes the edge under consideration that connects the nodes v1 and v2; • ω(e) denotes the (positive) weight on the edge e; • ω(v1), ω(v2) denote the (positive) weights associated with the nodes v1 and v2, respectively; • ev1, ev2 denote the set of edges connected to nodes v1 and v2, respectively. Note that in equ. (1) only edges parallel to a given edge e are taken into account, i.e. only edges that share a node with e. We highlight that, by its very definition, Forman's discrete curvature is associated 2 Figure 1: Characterization of a weighted and undirected peer-to-peer network (email correspondence [22,25]) with Forman-Ricci-curvature. A: Network plot. Node sizes are scaled with respect to their node degrees. B: (Weighted) node degree distribution. C: Curvature map, representing the Forman-Ricci-curvature along the network's edges. D: Histogram showing the distribution of the Forman-Ricci-curvature. 3 intrinsically to edges and therefore ideally suited for the study of networks. Particularly, it does not require any technical artifice in extending a node curvature measure to edges, as some other approaches do. In particular, there is no need to artificially generate and incorporate two- or higher dimensional faces: An approach that would impose severe constraints on computatbility. Additionally, a "good" discretization of Ricci curvature, such as Forman's proves to be [17], will capture the Ricci curvature's essential characteristic of measuring the growth rate - a property that is of special interest in the context of dynamic networks. Therefore, the Forman-Ricci curvature represents a way of determining whether a networks has the potential of growing infintely (negative curvature) or can only attain a maximal - and therefore computable - size (positive curvature). Clearly, this aspect represents a further motivation of studying the Ricci curvature of networks, since it allows to distinguish numerically between expander type networks of essentially negative curvature, such as peer-to-peer and small world networks that are on average of strictly negative curvature (see also [27]). 2.2 Characterizing large data sets with Ricci curvature We now want to explore the Forman curvature as a tool for characterizing real-world networks. Since this paper centers around peer-to-peer networks, we choose an example of email communication from [22]. In such network (denoted G), nodes describe correspondents and edges the exchange of messages. To characterize the network's structure with curvature, we have to impose normalized weighting schemes ω : V (G) (cid:55)→ [0, 1] γ : E(G) (cid:55)→ [0, 1] (nodes) (edges) (2) (3) on both nodes and edges. Naturally, we want to weight extensively used communication channels (edges) higher than rarely used ones. For this we calculate the minimum path length l between each pair of nodes (vi, vj) and impose (cid:40) 1 l , 0, γ(vi, vj) = l ≤ 6, vi ∼ vj else. (4) The motivation behind this choice of weights, lies in the "small world"-property (i.e. a maximum degree of separation of six [23]) that has been reportedly found in real-world. Accounting for this, we only check for indirect connections up to a path length of six and scale the weights according to the distribution. Analogousely, we impose a weighting scheme on the nodes. Naturally, the busiest communicators should have the highest weights. Therefore we choose a combinatorial weighting scheme based on node degree, i.e. the number and weight of connections for each node v: (cid:88) ω(v) = 1 deg(v) ei∼v γ(ei) . (5) The resulting structure of the network is shown in Fig. 1.A, the size of the nodes reflects their weights. Using edge and node weights, we can now determine the Forman curvature distribution in the network. A curvature map (Fig. 1.C) provides a planar representation that highlights clusters and distinguished regions. The histogram (Fig. 1D) shows the distribution of the curvature values allowing for comparison with the node degree distribution (Fig. 1.B). With indicating a correlation between the two distributions, the results highlight the strong influence of node degree weights on the network's topology. This is consistent with observations in email communications: Densly interconnected communities form around busy communication channels and active correspondents. 2.3 Ricci-flow with Forman curvature As mentioned earlier, the Ricci flow as a powerful geometric tool was devised by Hamilton [18] and further developed by Perleman [31, 32] in the course of his celebrated proof of the Poincare conjecture. Since then, it has continued to be an active and productive field of study, both in terms of theoretical questions, but also for diverse practical applications, including work by Gu et al. (see, e.g. [15]). Those mainly build on a combinatorial version introduced by Chow and Luo [8]. However, other discretizations of the flow, with reported applications in network and imaging sciences, are explored in the literature [27, 36]. 4 The classical Ricci flow is defined by ∂gij ∂t = −RicF(gij) · gij (6) where gij denotes the metric of the underlying manifold, represented by the earlier introduced weighting scheme of the network's edges. The reader might note the resemblance with the classical Laplace (or more precisely Laplace-Beltrami) flow that has become, by now, standard in Imaging and Graphics (see, e.g. [23, 44] and the references therein) being defined as (7) where I denotes the image, viewed as a parametrized surface in R3 (and ∆ denotes, as customary, the Laplacian)2. = ∆I ∂I ∂t The resemblance is neither accidental nor superficial. Indeed, the Ricci curvature can be viewed as a Laplacian of the metric. We shall address the practical implications of this observation in the sequel and a follow-up article by the authors that adresses more theortical questions of this matter. In our discrete setting, lengths are replaced by the (positive) edge weights. Time is assumed to evolve in discrete steps and each "clock" has a length of 1. With these constraints the Ricci flow takes the form γ(e) − γ(e) = −RicF(γ(e)) · γ(e) , (8) where γ(e) denotes the new (updated) value of γ(e) with γ(e) being the original - i.e. given - one. In this context, we want to point out and discuss a few issues and observations regarding this last equation: 1. At each iteration step (i.e. in the process of updating γ(e) to γ(e)), the Forman curvature has to be recomputed for each edge e, since it depends on its respective weight γ(e). This clearly increases the computational effort on magnitudes, however, the computation task is less formidable than it might appear at first. 2. As already stressed, we consider a discrete time model. Since for smoothing (denoising) a short time flow is to be applied3 only a small number of iterations need be considered. The precise number of necessary iteration is to be determined experimentally. Even though a typical number can be found easily, best results may be obtained for slightly different numbers – depending on the network, and the type and level of the noise, of course. 3. Forman also devised a continuous flow [17]. In the context of the present article, a continous setting is not required, but for other types of networks, where the evolution is continuous in time, it might be better to implement the other variant. In addition to the Ricci flow above, one can consider the scalar curvature flow that in our case will have the form: where ei = ei(v, vi) denote the edges through the node v, and scalF (v) the (Forman) scalar curvature at a node v, which we define by d dt γ(ei) = − 1 2 (cid:0)scalF (v) − scalF (vi)(cid:1)γ(ei) , (cid:88) RicF (γ(ei)) . scalF (v) = ei∼v (9) (10) 2.4 Characterizing dynamic data with Ricci Flow The introduced Ricci-flow can be utilized to characterize dynamic data. Given snapshots of a system at various (discrete) times {ti}, we analyze the Ricci flow on the corresponding network representations. The flow yields insights into structural changes providing a tool to identify "interesting" network regions. Applications include efficient change detection in large dynamic data representing complex systems, as described in the following section. Let (ti)i∈I be a discrete time series with step size ∆t. Consider a complex dynamic system of whose behavior we have snapshots at times (ti) represented in weighted network graphs (Gi)i∈I . We disregard 2The difference in sign is due to the two different conventions common when defining the Laplacian 3Because, by the theory for the smooth case, a long time flow will produce a limiting state of the network. 5 Figure 2: Schematic overview of the change detection workflow. A: We consider a set of "snapshots" of a system or data base at discrete times (ti)i∈I with step size ∆t. B: We infere unweighted (binary) networks from each snapshot that represent the structure of the underlying data. To simplify comparison, we normalize all networks. C: By superimposing weighting schemes based on "indirect connections", we extend the unweighted networks to weighted ones (see section 2). D: We calculate the Ricci flow for each time step ∆t by iterating over a the given scheme. E: For detection of changes, we compare the final (smoothed) weighting schemes after K iterations. F: To identify regions that were subject to significant change, we threshold the corrleation matrix obtained in (E). Light regions in the resulting map indicate such regions. any self-loops, i.e. edges connecting a node with itself. Let tn and tn+1 be consecutive time points with corresponding graphs Gn and Gn+1. The weighting schemes of the nodes and edges n,n+1 : V (G) (cid:55)→ [0, 1] ω0 n,n+1 : E(G) (cid:55)→ [0, 1] γ0 (11) (12) characterize the topological structure of the system at times tn and tn+1. We can estimate the Ricci-flow for the time step ∆t by iterating K times over γk+1 n,n+1(ei) = γk n,n+1(ei) − ∆t · RicF (γk n,n+1(ei)) · γk n,n+1(ei) (13) resulting in modified weighting schemes γK n+1 respectively. The correlation between these weight- ing schemes characterizes the flow. Regions that were subject to significant change during the time ∆t can be identified by thresholding the resulting correlation matrix. n and γK 6 Figure 3: We analyze an Internet peer-to-peer network representing Gnutella file exchanges on two consecutive days (August 8 and August 9 2002, from [19, 24]). A: Network plot (left) and curvature map (right) displaying the distribution of Forman curvature for a Gnutella snapshot at August 8. B: Analogous plots for a Gnuttela snapshot from the following day, August 9. 7 Figure 4: Detection of changes and regions of distinguished activity in Gnutella snapshots of two consecutive days [19, 24] with Ricci flow and a parameter choice of K = 10 and ∆t = 0.8. The highlighted spots correspond to single edges and assortments of edges and nodes (clusters) with high activity (flow). 3 Application 3.1 Change detection with Ricci flow A major challenge of modern data science lies in characterizing dynamic effects in large data sets, such as structural changes in discrete time series of "snapshots" of the state a system or frequently updated large data bases. Commonly, network graphs are infered from data representing interactions and associations in the underlying data. In the case of peer-to-peer networks, the network describes the information flow (edges) between the peers (nodes). We want to use the Forman-Ricci curvature to analyze dynamic changes in the structure of such interaction networks infered from large data sets. Specifically, we want to characterize the information flow between the network's nodes using the previousely introduced Ricci flow. Our method follows formalism described in section 2 and is schematically displayed in Fig. 2. The analysis of the information flow can be used to detect changes or distinguished regions of activity in the data. Applications include the curation of large open-access data bases and the detection of rare events in experimental data, such as spiking neurons in measurements of neuronal activity. 3.2 Analysis of Gnutella peer-to-peer network We consider a series of discrete time snapshots of a complex peer-to-peer system, represented as network graphs (Gi)i∈I . To characterize the Ricci flow, we apply the earlier described formalism pairwise, i.e. we iterate over (13) for snapshots (Gn, Gn+1) at consecutive time points tn and tn+1. Here we use the file- exachange service Gnutella as an example, analyzing the peer-to-peer networks resulting from exchange activities on two consecutive days (August 8 and August 9 2002, [19, 24]). Fig. 3 shows the networks infered from the data sets and the corresponding curvature maps with the distribution of Forman Ricci curvature. We applied our change detection method with a correlation threshold of t = 0.9 to detect regions of significant changes, i.e. groups of peers with significant activity. The results are shown in Fig. 4, represented as a heatmap. Light spots in the heatmap correspond to network regions with large flow and structural changes allowing for detection and localization of such dynamic effects. The method provides a clear representation of dynamic changes in networks, especially in terms of the community structure of the network. Given the intrinsic community structure of a network (clusters), which is also hinted in the Forman curvature maps, one can examine the influence of the flow on this specific structural property.. 4 Discussion and Future Work The dawning age of big data opens up great numbers of possibilities and perspectives to gain insights in the principles of nature, humanity and technology through collection and (statistical) analyis of data. However, the vaste amount of available data challenges our analysis methods leading to an increased need of automated tools that can perform rapid and efficient data evaluations. 8 Networks are an efficient and commonly used data representation, emphasizing on interactions and as- sociations. This representation is ideal for analyzing structures within the data under geometric aspects. We have used networks to characterize peer-to-peer systems and analyze dynamic effects in informa- tion transfer between its peers. Particularly, we introduced a method for detecting changes in these dynamics. Possible applications of this theoretical framework include denoising of experimental data and identification of "interesting" groups of data points and activities of network regions. The geometric methods we used in the present article are build on R. Forman's work on Ricci curvature in networks and the corresponding Ricci flow based on this definition. Future work, especially a follow-up article by the authors, will expand the range of geometric tools used in the methods and develop a deeper understanding of theoretical aspects. In what follows, we want to name and discuss some extensions and theoretical considerations that we shall adress in future work. One important fact, whose implications we shall discuss later on, is the so called Bochner-Weitzenboeck formula (see, e.g. [20]), which relates graph Laplacian and Ricci curvature through an algebraic-geometric approach. More precisely, it prescribes a correction term for the standard Laplacian (or Laplace-Beltrami) operator, in terms of the curvature of the underlying manifold. Given that the Laplacian plays a key role in the heat equation (see, e.g. [20]), it is easy to gain some basic physical intuition behind the phenomenon of curvature and flow: The heat evolution on a curved metal plate differs from that on a planar one in a manner that is evidently dependent on the shape (i.e., curvature) of the plate. This conducts us to a number of prospective future directions: 1. A task that is almost self evident, is to further experiment with very large data sets (numbers of data points in the order of ten thousand and more); 2. Another natural target is the use of our method on different types of networks, with special emphasis on Biological Networks; 3. A statistical analysis regarding the Ricci flow, similar to the one presented here and in [14], should also be performed on various standard types of networks in order to confirm and calibrate the characterization and classifying capabilities of the Ricci curvature and flow. Slightly more demanding are future experiments and comparisons with the related flows, namely 1. The Forman curvature versions of the scalar and Laplace-Beltrami flows. Especially the last one seems to be quite promising for network denoising, as applications of the analogous flow in image processing showed [38]. Moreover, the Forman-Ricci curvature comes naturally coupled with a fit- ting version of the so called Bochner Laplacian (and yet with another, intrinsically connected, rough Laplacian). This aspect is subject to currently ongoing work and will be covered in a forthcoming paper by the authors. 2. Here, as for the short time Ricci flow, statistical analysis should be undertaken to validate the classification potential of the long term Ricci flow. A more ambitious, yet still feasible, future direction would be to explore network stability by considering the long time Forman-Ricci flow (as opposed to the short time one employed for denoising). This approach would exploit, in analogy with the smooth case [31, 32], the propensity of the Ricci flow to preserve and quantify the overall, global Geometry (i.e. curvature) and essential topology of the network. This would allow us to study the evolution of a network "under its own pressure" and to detect and examine catastrophic events as virus attacks and denial of service attempts. Given the basic numerical simplicity of our method, this approach might prove to be an effective alternative to the Persistent Homology method (see, e.g. [33]) for the 1-dimensional case of networks. Moreover, the Ricci flow does not need to make appeal to higher dimensional structures (namely simplicial complexes) that are necessary for the Persistent Homology based applications, with clear computational – but also theoretically rigor – advantages. The potential benefits of the Ricci flow would be, in fact, even greater, given that it deals with weighted networks, not just with their unweighted, combinatorial counterparts used in Persistent Homology. Acknowledgements ES acknowledges the warm support of the Max-Planck-Institute for Mathematics in the Sciences, Leipzig, for the warm hospitality during the writing of this paper. He would also like to thank Areejit Samal for many interesting discussions. MW was supported by a scholarship of the Konrad Adenauer Foundation. 9 References [1] R. Albert and A.-L. Barab´asi. Statistical mechanics of complex networks. Reviews of Modern Physics, 74(1):47, 2002. [2] A. Banerjee and J. Jost. Spectral plot properties: Towards a qualitative classification of networks. In In European Conference on Complex Systems, 2007. [3] A.-L. Barabasi. Network Science. Cambridge University Press, 2016. [4] A.-L. Barab´asi and R. Albert. Emergence of scaling in random networks. Science, 286(5439):509–512, 1999. [5] A. L. Barab´asi and Z. N. Oltvai. Network biology: understanding the cell's functional organization. Nature Reviews Genetics, 5(2):101–113, 2004. [6] M. Barth´elemy. Spatial networks. Physics Reports, 499(1):1–101, 2011. [7] F. Bauer, J. Jost, and S. Liu. Ollivier-ricci curvature and the spectrum of the normalized graph laplace operator. Mathematical research letters, 19:1185–1205, 2012. [8] B. Chow and F. Luo. Combinatorial ricci flows on surfaces. Journal of Differential Geometry, 63(1):97–129, 2003. [9] E. Saucan E. Appleboim and Y. Y. Zeevi. Ricci curvature and flow for image denoising and superes- olution. In Proceedings of EUSIPCO 2012, volume ., pages 2743–2747, 2012. [10] G. Wolansky E. Saucan, E. Appleboim and Y. Y. Zeevi. Combinatorial ricci curvature and laplacians for image processing. In Proceedings of CISP'09, volume 2, pages 992–997, 2009. [11] E. Appelboim E. Sonn, E. Saucan and Y. Y. Zeevi. Ricci flow for image processing. In IEEEI 2014, volume ., page ., 2014. [12] J. Eckmann and E. Moses. Curvature of co-links uncovers hidden thematic layers in the world wide web. Proceedings of the National Academy of Sciences, 99(9):5825–5829, 2002. [13] N. B. Ellison, C. Steinfield, and C. Lampe. The benefits of facebook friends: Social capital and college students use of online social network sites. Journal of Computer-Mediated Communication, 12(4):1143–1168, 2007. [14] R. P. Sreejith et al. Forman curvature for complex networks. arXiv:1603.00386, 2016. [15] R. Sarkar et al. Greedy routing with guaranteed delivery using ricci flows. In Proc. of the 8th International Symposium on Information Processing in Sensor Networks (IPSN'09), volume ., pages 121–132, 2009. [16] R. Forman. Bochner's method for cell complexes and combinatorial ricci curvature. Discrete and Computational Geometry, 29(3):323–374, 2003. [17] R. Forman. Bochner's method for cell complexes and combinatorial ricci curvature. Discrete and Computational Geometry, 29(3):323–374, 2003. [18] R. S. Hamilton. The ricci flow on surfaces. mathematics and general relativity. In Contemp. Math, Amer. Math. Soc., volume 71, pages 237–262, 1986. [19] J. Kleinberg J. Leskovec and C. Faloutsos. Graph Evolution: Densification and Shrinking Diameters. In ACM Transactions on Knowledge Discovery from Data (ACM TKDD), volume 1(1), 2007. [20] J. Jost. Riemannian Geometry and Geometric Analysis. Springer, 2011. [21] S. Jost, J.and Liu. Olliviers ricci curvature, local clustering and curvature-dimension inequalities on graphs. Discrete & Computational Geometry, 51(2):300–322, 2014. [22] J. Kunegis. Konect - the koblenz network collection. In Proc. Int. Conf. on World Wide Web Companion, pages 1343–1350, 2013. [23] l. de Sola Pool and M. Kochen. Contacts and influence. Social Networks, 1(1):5 – 51, 1978. 10 [24] I. Foster M. Ripeanu and A. Iamnitchi. Mapping the Gnutella Network: Properties of Large-Scale Peer-to-Peer Systems and Implications for System Design. In IEEE Internet Computing Journal, 2002. [25] R. Michalski and S. P. Palus. Matching organizational structure and social network extracted from email communication. In Lecture Notes in Business Information Processing, volume 87, pages 197– 206. Springer Berlin Heidelberg, 2011. [26] O. Narayan and I. Saniee. Large-scale curvature of networks. Physical Review E, 84(6):066108, 2011. [27] C. Ni, Y. Lin, J. Gao, X. D. Gu, and E. Saucan. Ricci curvature of the internet topology. In IEEE Conference onComputer Communications (INFOCOM), pages 2758–2766. IEEE, 2015. [28] Y. Ollivier. Ricci curvature of markov chains on metric spaces. Journal of Functional Analysis, 256(3):810–864, 2009. [29] Y. Ollivier. A survey of ricci curvature for metric spaces and markov chains. Probabilistic approach to geometry, 57:343–381, 2010. [30] Y. Ollivier. A visual introduction to riemannian curvatures and some discrete generalizations. Anal- ysis and Geometry of Metric Measure Spaces: Lecture Notes of the 50th S´eminaire de Math´ematiques Sup´erieures (SMS), Montr´eal, 2011, pages 197–219, 2013. [31] G. J. Perelman. The entropy formula for the ricci flow and its geometric applications. arXiv:math/0211159, 2002. [32] G. J. Perelman. Ricci flow with surgery on three-manifolds. arXiv:math/0303109, 2003. [33] G. Petri, P. Expert, F. F. Turkheimer, R. Carhart-Harris, D. Nutt, P. J. Hellyer, and F. Vac- carino. Homological scaffolds of brain functional networks. Journal of The Royal Society Interface, 11(101):20140873, 2014. [34] R. Sandhu, T. Georgiou, E. Reznik, L. Zhu, I. Kolesov, Y. Senbabaoglu, and A. Tannenbaum. Graph curvature for differentiating cancer networks. Scientific Reports, 5, 2015. [35] R. Sandhu, T. Georgiou, and A. Tannenbaum. Market fragility, systemic risk, and ricci curvature. arXiv:1505.05182, . [36] E. Saucan. A metric ricci flow for surfaces and its applications. Geometry, Imaging and Computing, 1(2):259–301, 2014. [37] E. Saucan and E. Appleboim. Curvature based clustering for dna microarray data analysis. In Pattern Recognition and Image Analysis, pages 405–412. Springer, 2005. [38] E. Saucan, E. Appleboim, G. Wolanski, and Y. Zeevi. Combinatorial ricci curvature for image In MICCAI 2008 Workshop Manifolds in Medical Imaging: Metrics, Learning and processing. Beyond, 2008. [39] Y. Shavitt and T. Tankel. On the curvature of the internet and its usage for overlay construction and distance estimation. In INFOCOM 2004. Twenty-third AnnualJoint Conference of the IEEE Computer and Communications Societies, volume 1. IEEE, 2004. [40] L. Subelj and M. Bajec. Robust network community detection using balanced propagation. The European Physical Journal B, 81(3):353–362, 2011. [41] D. J. Watts and S. H. Strogatz. Collective dynamics of small-world networks. Nature, 393(6684):440– 442, 1998. [42] M. Weber, S. Ballouz, P. Pavlidis, and J. Gillis. Egad: Ultra-fast functional analysis of gene networks. preprint, 2016. [43] Z. Wu, G. Menichetti, C. Rahmede, and G. Bianconi. Emergent complex network geometry. Scientific Reports, 5, 2015. [44] G. Xu. Discrete laplacebeltrami operators and their convergence. Computer Aided Geometric Design, 21:767–784, 2004. 11
1906.12335
1
1906
2019-06-27T13:51:30
Critical Edge Identification: A K-Truss Based Model
[ "cs.SI", "cs.DB" ]
In a social network, the strength of relationships between users can significantly affect the stability of the network. In this paper, we use the k-truss model to measure the stability of a social network. To identify critical connections, we propose a novel problem, named k-truss minimization. Given a social network G and a budget b, it aims to find b edges for deletion which can lead to the maximum number of edge breaks in the k-truss of G. We show that the problem is NP-hard. To accelerate the computation, novel pruning rules are developed to reduce the candidate size. In addition, we propose an upper bound based strategy to further reduce the searching space. Comprehensive experiments are conducted over real social networks to demonstrate the efficiency and effectiveness of the proposed techniques.
cs.SI
cs
Critical Edge Identification: A K-Truss Based Model Weijie Zhu1,3 , Mengqi Zhang2 , Chen Chen1∗ , Xiaoyang Wang2 , Fan Zhang4 , Xuemin Lin1,3,4 1East China Normal University, China 2Zhejiang Gongshang University, China 3Zhejiang Lab, Hangzhou, China 4The University of New South Wales, Australia {weijie.zhu93, mengqiz.zjgsu, fanzhang.cs}@gmail.com, {chenc, xiaoyangw}@zjgsu.edu.cn, [email protected] 9 1 0 2 n u J 7 2 ] I S . s c [ 1 v 5 3 3 2 1 . 6 0 9 1 : v i X r a Abstract In a social network, the strength of relationships between users can significantly affect the stability of the network. In this paper, we use the k-truss model to measure the stability of a social network. To identify critical connections, we propose a novel problem, named k-truss minimization. Given a so- cial network G and a budget b, it aims to find b edges for deletion which can lead to the maximum number of edge breaks in the k-truss of G. We show that the problem is NP-hard. To accelerate the computation, novel pruning rules are developed to reduce the candidate size. In addition, we pro- pose an upper bound based strategy to further re- duce the searching space. Comprehensive experi- ments are conducted over real social networks to demonstrate the efficiency and effectiveness of the proposed techniques. 1 Introduction As a key problem in graph theory and social network analy- sis, the mining of cohesive subgraphs, such as k-core, k-truss, clique, etc, has found many important applications in real life [Cohen, 2008; Tsourakakis et al., 2013; Wen et al., 2016; Yu et al., 2013]. The mined cohesive subgraph can serve as an important metric to evaluate the properties of a network, such as network engagement. In this paper, we use the k-truss model to measure the cohesiveness of a social network. Un- like k-core, k-truss not only emphasizes the users' engaged activities (i.e., number of friends), but also requires strong connections among users. That is, the k-truss of G is the max- imal subgraph where each edge is involved in at least k − 2 triangles. Note that triangle is an important building block for the analysis of social network structure [Xiao et al., 2017; Cui et al., 2018]. Thus the number of edges in the k-truss can be utilized to measure the stability of network structure. The breakdown of a strong connection may affect other re- lationships, which can make certain relationships involved in less than k−2 triangles and removed from the k-truss. Hence, it will lead to a cascading breakdown of relationships even- tually. To identify the critical edges, in this paper, we in- *Corresponding author Figure 1: Motivation Example vestigate the k-truss minimization problem. Given a social network G and a budget b, k-truss minimization aims to find a set B of b edges, which will result in the largest number of edge breaks in the k-truss by deleting B. Figure 1 is a toy social network with 10 users. Suppose k is 4. Then only the blue and red edges belong to the 4-truss. If we delete edge (v2, v5), it will affect the connections among other users and lead to the removal of all the blue edges from the 4-truss, since they no longer meet the requirement of 4- truss. We can see that the deletion of one single edge can se- riously collapse the social network. The k-truss minimization problem can find many applications in real life. For instance, given a social network, we can reinforce the community by paying more attention to the critical relationships. Also, we can strengthen the important connections to enhance the sta- bility of a communication network or detect vital connections in enemy's network for military purpose. The main challenges of this problem lie in the following two aspects. Firstly, we prove that the problem is NP-hard. It means that it is non-trivial to obtain the result in polyno- mial time. Secondly, the number of edges in a social network is usually quite large. Even if we only need to consider the edges in k-truss as candidates, it is still a large amount of edges to explore. To the best of our knowledge, we are the first to investigate the k-truss minimization problem through edge deletion. We formally define the problem and prove its hardness. Novel pruning rules are developed to reduce the searching space. To further speed up the computation, an up- per bound based strategy is proposed. 2 Preliminaries 2.1 Problem Definition We consider a social network G as an undirected graph. Given a subgraph S ⊆ G, we use VS (resp. ES) to denote 4-truss10912345768 the set of nodes (resp. edges) in S. N (u, S) is the neighbors of u in S. deg(u, S) equals N (u, S), denoting the degree of u in S. m = EG is the number of edges in G. Assum- ing the length of each edge equals 1, a triangle is a cycle of length 3 in the graph. For e ∈ EG, a containing-e-triangle is a triangle which contains e. Definition 1 (k-core). Given a graph G, a subgraph S is the k-core of G, denoted as Ck, if (i) S satisfies degree constraint, i.e., deg(u, S) ≥ k for every u ∈ VS; and (ii) S is maximal, i.e., any supergraph of S cannot be a k-core. Definition 2 (edge support). Given a subgraph S ⊆ G and an edge e ∈ ES, the edge support of e is the number of containing-e-triangles in S, denoted as sup(e, S). Definition 3 (k-truss). Given a graph G, a subgraph S is the k-truss of G, denoted by Tk, if (i) sup(e, S) ≥ k − 2 for every edge e ∈ ES; (ii) S is maximal, i.e., any supergraph of S cannot be a k-truss; and (iii) S is non-trivial, i.e., no isolated node in S. Definition 4 (trussness). The trussness of an edge e ∈ EG, denoted as τ (e), is the largest integer k that satisfies e ∈ ETk and e /∈ ETk+1. Based on the definitions of k-core and k-truss, we can see that k-truss not only requires sufficient number of neighbors, but also has strict constraint over the strength of edges. A k-truss is at least a (k-1)-core. Therefore, to compute the k- truss, we can first compute the (k-1)-core and then find the k-truss over (k-1)-core by iteratively removing all the edges that violate the k-truss constraint. The time complexity is O(m1.5) [Wang and Cheng, 2012]. Given a set B of edges k to denote the k-truss after deleting B. We in G, we use T B k . We define use T B the followers F (B, Tk) of B as the edges that are removed from Tk due to the deletion of B. Then our problem can be formally defined as follows. Given a graph G and a budget b, the k-truss minimization problem aims to find a set B∗ of b edges, such that the T B∗ k is minimized. It is also equivalent to finding an edge set B∗ that can maximize F (B∗, Tk), i.e., k to denote the number of edges in T B ∗ B = arg max B⊆EG∧B=bF (B, Tk). According to Theorem 1 and 2, the k-truss minimization problem is NP-hard for k ≥ 5, and the objective function is monotonic but not submodular. Theorem 1. For k ≥ 5, the k-truss minimization problem is NP-hard. Proof. For k ≥ 5, we sketch the proof for k = 5. A simi- lar construction can be applied for the case of k > 5. When k = 5, we reduce the k-truss minimization problem from the maximum coverage problem [Karp, 1972], which aims to find b sets to cover the largest number of elements, where b is a given budget. We consider an instance of maximum coverage problem with s sets T1, T2, .., Ts and t elements {e1, .., et} = ∪1≤i≤sTi. We assume that the maximum num- ber of elements inside T is R ≤ t. Then we construct a corresponding instance of the k-truss minimization problem 0, vi (a) Constructed Example for NP-hard Proof (b) Structure Illustration (c) Construction of V for R = 3 Figure 2: Example for NP-hard in a graph G as follows. Figure 2(a) is a constructed example for s = 3, t = 4, R = 2. 0 and vi 1, ..., vi 4R−2ri We divide G into three parts, V , N and P . 1) V consists of s parts. Each part Vi corresponds to Ti in the maxi- mum coverage problem instance. 2) N consists of t parts. Each part Ni corresponds to ei in the maximum coverage problem instance. 3) P is a dense subgraph. The support of edges in P is no less than k − 2 + b. Specifically, suppose Ti consists of ri ≤ R elements, Vi consists of 4R − ri + 1 nodes and 8R − ri edges. To construct Vi, we first construct a (4R − 2ri)-polygon. Then, we add 0 in the center of (4R − 2ri)-polygon and add a node vi 4R − 2ri edges between vi . Finally, we and 3ri edges further add ri nodes vi 4R−2ri+1), ..., (vi 1, vi {(vi 0, 4R−ri)}. With the con- vi 4R−ri), (vi 4R−ri), (vi struction, the edges in V have support no larger than 3. We use P to provide support for edges in V and make the support of edges in V to be 3. Each part in N consists of 2R + 2 nodes and the structure is a list of 4R triangles which is shown in Figure 2(a). For each element ei in Tj, we add two triangles between Ni and Vj to make them triangle connected. The structure is shown in 2(b). Note that each edge in Ni and Vj can be used at most once. We can see that edges in N have support no larger than 3. Finally, we use P to provide support for edges in N and make the support of edges in N to be 3. Then the construction is completed. The construction of Vi for R = 3 is shown in Figure 2(c). 4R−2ri+1, ..., vi 4R−2ri+1), (vi 4R−2ri+1), (vi 2ri−1, vi 4R−ri 2, vi 2ri, vi With the construction, we can guarantee that 1) deleting any edge in Vi can make all the edges in Vi and the edges in Nj who have connections with Vi deleted from the truss. T1:{e1,e2}T1:{e1,e2}T2:{e2,e3}T2:{e2,e3}T3:{e4}T3:{e4}e1e1PPV1V1V2V2V3V3N1N1N2N2N3N3N4N4e2e2e3e3e4e4v11v11v12v12v13v13v14v14v10v10v15v15v16v16v21v21v23v23v22v22v26v26v20v20v31v31v32v32v33v33v34v34v35v35v36v36v30v30v37v37v25v25v24v24s=3s=3t=4t=4GGR=2R=2=aabbccddaabbccddsup((a,d))=k2sup((a,d))=k2sup((b,d))>k2sup((b,d))>k2sup((a,c))>k2sup((a,c))>k2r=3r=3r=2r=2 3 4 5 6 7 14 15 16 17 26 27 28 29 30 31 Algorithm 1: Baseline Algorithm Input : G: a social network, k: truss constraint, b: the budget Output: B: the set of deleted edges 1 B ← ∅ ; Tk ← k-truss of G; 2 while B < b do e∗ ← arg maxe∈ETk F (e, Tk) ; delete e∗ from Tk and update Tk ; B ← B ∪ {e∗ } ; 3 4 5 6 end while 7 return B 2) Only the edges in Vi can be considered as candidates. 3) Except the followers in N, each Vi has the same number of followers. In Figure 2(a), deletion of each Vi can make 8R edges (except the edges in N) removed. Consequently, the optimal solution of k-truss minimization problem is the same as the maximum coverage problem. Since the maximum cov- erage problem is NP-hard, the theorem holds. Theorem 2. The objective function f (x) = F (x, Tk) is monotonic but not submodular. Proof. Suppose B ⊆ B(cid:48). For every edge e in F (B, Tk), e will be deleted from the k-truss when deleting B(cid:48). Thus f (B) ≤ f (B(cid:48)) and f is monotonic. Given two sets A and B, if f is submodular, it must hold that f (A ∪ B) + f (A ∩ B) ≤ f (A) + f (B). We show that the inequality does not hold by constructing a counter example. In Figure 1, for k = 4, suppose A = {(v5, v6)} and B = {(v7, v8)}. We have f (A) = 4, f (B) = 0, f (A ∪ B) = 12 and f (A ∩ B) = 0. The inequation does not hold. f is not submodular. 2.2 Baseline Algorithm For the k-truss minimization problem, a naive solution is to enumerate all the possible edge sets of size b, and return the best one. However, the size of a real-world social network is usually very large. The number of combinations is enormous to enumerate. Due to the complexity and non-submodular property of the problem, we resort to the greedy framework. Algorithm 1 shows the baseline greedy algorithm. It is easy to verify that we only need to consider the edges in the k-truss as candidates. The algorithm iteratively finds the edge with the largest number of followers in the current k-truss (Line 3). The algorithm terminates when b edges are found. The time complexity of the baseline algorithm is O(bm2.5). 3 Group Based Solution In this section, novel pruning techniques are developed to ac- celerate the search in baseline algorithm. 3.1 Candidate Reduction Before introducing the pruning rules, we first present some definitions involved. Algorithm 2: Group based Algorithm Input : G: a social network, k: truss constraint, b: the budget Output: B: the set of deleted edges 1 B ← ∅ ; Tk ← k-truss of G ; k-truss */; 2 while B < b do /* compute mark all edges in Tk as unvisited ; T ← FindGroup (Tk) ; /* Line 12-19 */; for each e in T do compute F (e, Tk) ; T ← T\F (e, Tk) ; ← the edge with the most followers ; e∗ update k-truss Tk ; B ← B ∪ {e∗ } ; 8 9 10 11 return B 12 Function FindGroup (S): 13 C ← ∅ ; gID ← 0; candidates */; for each e ∈ S do /* C stores the if sup(e, S) = k − 2 and e is unvisited then /* Line GroupExpansion (S, e); 20-32 */; gID++ ; return C 18 19 End Function 20 Function GroupExpansion (S, e): 21 22 23 24 25 Q ← ∅ ; Q.enqueue(e); mark e as visited ; while Q (cid:54)= ∅ do e(cid:48)(u, v) ← Q.dequeue(); foreach a ∈ N (u, Tk) ∩ N (v, Tk) do if (u, a) is unvisited and sup = k − 2 then Q.enqueue((u, a)) ; mark (u, a) as visited ; if (v, a) is unvisited and sup = k − 2 then Q.enqueue((v, a)) ; mark (v, a) as visited ; update C ; 32 End Function Definition 5 (triangle adjacency). Given two triangles (cid:52)1, (cid:52)2 in G, they are triangle adjacent if (cid:52)1 and (cid:52)2 share a common edge, which means (cid:52)1 ∩ (cid:52)2 (cid:54)= ∅. Definition 6 (triangle connectivity). Given two triangles (cid:52)s,(cid:52)t in G, they are triangle connected, denoted as (cid:52)s ↔ (cid:52)t, if there exists a sequence of θ triangles (cid:52)1,(cid:52)2, ...,(cid:52)θ in G, such that (cid:52)s = (cid:52)1,(cid:52)t = (cid:52)θ, and for 1 ≤ i < θ, (cid:52)i and (cid:52)i+1 are triangle adjacent. For two edges e and e(cid:48), we say they are triangle adjacent, if e and e(cid:48) belong to the same triangle. As shown in the base- line algorithm, we only need to consider the edges in Tk as candidates. Lemma 1 shows that we only need to explore the edges in Q. Lemma 1. Given a k-truss Tk, let P = {e sup(e, Tk) = k − 2}. If an edge e has at least one follower, e must be in Q, where Q = {e e ∈ Tk ∧∃e(cid:48) ∈ P where e and e(cid:48) are triangle adjacent}. Proof. We prove the lemma by showing that edges in EG \ Q do not have followers. We divide EG \ Q into two sets. 1) For edge with trussness less than k, it will be deleted during the k-truss computation. 2) For an edge e in Tk, if e is not triangle adjacent with any edge in P , it means e is triangle adjacent with edges such as e(cid:48) whose sup(e(cid:48), Tk) > k − 2. If we delete e, all the edges triangle adjacent with e will still have support at least k − 2 in Tk. Thus, e has no follower. The lemma is correct. Based on Lemma 2, we can skip the edges that are the fol- lowers of the explored ones. Lemma 2. Given two edges e1, e2 ∈ Tk, if e1 ∈ F (e2, Tk), then we have F (e1, Tk) ⊆ F (e2, Tk). Proof. e1 ∈ F (e2, Tk), it implies that e1 will be deleted dur- ing the deletion of e2. Therefore, each edge in F (e1, Tk) will be deleted when e2 is deleted. Consequently, we have F (e1, Tk) ⊆ F (e2, Tk). To further reduce the searching space, we introduce a prun- ing rule based on k-support group. Definition 7 (k-support group). Given a k-truss Tk, a sub- graph S ⊆ Tk is a k-support group if it satisfies : 1) ∀e ∈ S, sup(e, Tk) = k − 2. 2) ∀e1, e2 ∈ S, suppose e1 ∈ (cid:52)s, e2 ∈ (cid:52)t. There exists a sequence of θ ≥ 2 triangles (cid:52)1, ...,(cid:52)θ with (cid:52)s = (cid:52)1, (cid:52)t = (cid:52)θ. For i ∈ [1, θ), (cid:52)i ∩(cid:52)i+1 = e and sup(e, Tk) = k − 2. 3) S is maximal, i.e., any supergraph of S cannot be a k-support group. Lemma 3 shows that edges in the same k-support group are equivalent. The deletion of any edge in a k-support group can lead to the deletion of the whole k-support group. Lemma 3. S is a k-support group of Tk. For ∀e ∈ S, if we delete e, we can have S deleted from Tk. Proof. Since S is a k-support group of Tk, for ∀e, e(cid:48) ∈ S, suppose that e ∈ (cid:52)s, e(cid:48) ∈ (cid:52)t, there exists a sequence of θ tri- angles (cid:52)1, ...,(cid:52)θ with (cid:52)s = (cid:52)1,(cid:52)t = (cid:52)θ. For i ∈ [1, θ), (cid:52)i ∩ (cid:52)i+1 = ei and sup(ei, Tk) = k − 2. The deletion of any edge inside the group will destroy the corresponding triangles and decrease the support of triangle adjacent edges by 1. It will lead to a cascading deletion of subsequent trian- gle edges in the group due to the violation of truss constraint. Therefore, the lemma holds. According to Lemma 3, we only need to add one edge from a k-support group to the candidate set, and the other edges in the group can be treated as the followers of the selected edge. In the following lemma, we can further prune the edges that are adjacent with multiple edges in a k-support group. Lemma 4. Suppose that e ∈ Tk and sup(e, Tk) = w > k−2. For a k-support group S, if e belongs to more than w − k + 2 triangles, each of which contains at least one edge in S, then e is a follower of S. Proof. According to Lemma 3, by removing an edge from S, we have S deleted from Tk. Since e belongs to more than w − k + 2 triangles, each of which contains at least one edge in S, the support of e will decrease by more than w − k + 2 due to the deletion of S. So its support will be less than k − 2 and it will be deleted due to the support constraint. Thus, e is a follower of S. 3.2 Group Based Algorithm We improve the baseline algorithm by integrating all the pruning rules above, and the details are shown in Algorithm 2. In each iteration, we first find k-support groups of current Tk and compute the candidate set T according to Lemma 3 (Line 4). This process, i.e., FindGroup function, corresponds to Line 12-19. It can be done by conducting BFS search from edges in Tk. We use a hash table to maintain the group id (i.e., gID) for each edge and the gID starts from 0 (Line 13). For each unvisited edge with support of k − 2, we conduct a BFS search from it by calling function GroupExpansion (Line 20-32). During the BFS search, we visit the edges that are triangle adjacent with the current edge, and push the edges with support of k − 2 into the queue if they are not visited (Line 25 and 28). The edges, which are visited in the same BFS round, are marked with the current gID. For the visited edges with support larger than k − 2, we use a hash table to record its coverage with the current k-support group, and update the candidate set based on Lemma 4 (Line 31). Ac- cording to Lemma 2, we can further update the candidate set after computing the followers of edges (Line 7). 4 Upper Bound Based Solution The group based algorithm reduces the size of candidate set by excluding the edges in the same k-support group and the followers of k-support groups, which greatly accelerates the baseline method. However, for each candidate edge, we still need lots of computation to find its followers. Given an edge, if we can obtain the upper bound of its follower size, then we can speed up the search by pruning unpromising candidates. In this section, we present a novel method to efficiently cal- culate the upper bound required. 4.1 Upper Bound Derivation Before introducing the lemma, we first present some basic definitions. Recall that τ (e) denotes the trussness of e. Definition 8 (k-triangle). A triangle (cid:52)uvw is a k-triangle, if the trussness of each edge is no less than k. Definition 9 (k-triangle connectivity). Two triangles (cid:52)s and (cid:52)t are k-triangle connected, denoted as (cid:52)s ↔ (cid:52)t, if there exists a sequence of θ ≥ 2 triangles (cid:52)1, ...,(cid:52)θ with (cid:52)s = (cid:52)1,(cid:52)t = (cid:52)θ. For i ∈ [1, θ), (cid:52)i ∩ (cid:52)i+1 = e and τ (e) = k. k k k k We say two edges e, e(cid:48) are k-triangle connected, denoted ↔ e(cid:48), if and only if 1) e and e(cid:48) belong to the same k- as e triangle, or 2) e ∈ (cid:52)s, e(cid:48) Definition 10 (k-truss group). Given a graph G and an in- teger k ≥ 3, a subgraph S is a k-truss group if it satisfies: 1) ↔ e(cid:48). 3) S is maximal, ∀e ∈ S, τ (e) = k. 2) ∀e, e(cid:48) i.e., there is no supergraph of S satisfying conditions 1 and 2. Based on the definition of k-truss group, Lemma 5 gives ∈ (cid:52)t, with (cid:52)s ↔ (cid:52)t. ∈ S, e θ(cid:80) i=1Egi. an upper bound of F (e, Tk). Lemma 5. If e is triangle adjacent with θ k-truss groups g1, g2, ..., gθ, we have F (e, Tk) ≤ Proof. Suppose sup(e, Tk) = w, we have w ≥ k − 2, so e is contained by w triangles and is triangle adjacent with 2w edges. We divide the edges which are triangle adjacent with e in Tk into two parts. 1) τ (e(cid:48)) > k. Since the deletion of e may cause τ (e(cid:48)) to decrease at most 1 [Huang et al., 2014; Akbas and Zhao, 2017], we have τ (e(cid:48)) ≥ k after deleting e, which means e(cid:48) has no contribution to F (e, Tk). 2) τ (e(cid:48)) = k. Suppose e(cid:48) ∈ gi. The deletion of e can cause trussness of θ(cid:80) each edge in gi to decrease at most 1. Then e(cid:48) can contribute to F (e, Tk) with at most Egi. Thus, i=1Egi is an upper bound of F (e, Tk). 4.2 Upper Bound Based Algorithm Based on Lemma 5, we can skip the edges whose upper bound of follower size is less than the best edge in the current iteration. However, given the trussness of each edge, it may still be prohibitive to find the k-truss group that contains an edge e, since in the worst case we need to explore all the tri- angles in the graph. To compute the upper bound efficiently, we construct an index to maintain the relationships between edges and their k-truss groups. To find the k-truss group for a given edge e, we extend the GroupExpansion function in Line 20-32 of Algorithm 2. It also follows the BFS search manner. The difference is that when we explore an adjacent triangle, it must satisfy the k-triangle constraint, and we only enqueue an edge, whose trussness satisfies k-triangle connectivity constraint. After finishing the BFS search starting from e, its involved k-truss groups can be found. After deleting an edge e in the current iteration, the con- structed k-truss groups may be changed. Therefore, we need to update the k-truss groups for the next iteration. The up- date algorithm consists of two parts, i.e., update the trussness and update the groups affected by the changed trussness. To update the edge trussness, we apply the algorithm in [Huang et al., 2014], which can efficiently update the edge trussness after deleting an edge e. Given the edges with changed truss- ness, we first find the subgraph induced by these edges. Then we reconstruct the k-truss groups for the induced subgraph and update the original ones. Based on the k-truss groups constructed, we can compute the upper bound of followers for edges efficiently. The final algorithm, named UP-Edge, integrates all the techniques proposed in Section 3 and 4. 5 Experiment 5.1 Experiment Setting In the experiments, we implement and evaluate the following algorithms. 1) Exact: naive algorithm that enumerates all the combinations. 2) Support: in each iteration, it selects the edge that is triangle adjacent with the edge with minimum support in the k-truss. 3) Baseline: baseline algorithm in Section 2.2. 4) GP-Edge: group based algorithm in Section 3. 5) UP- Edge: upper bound based algorithm in Section 4. We employ 9 real social networks (i.e., Bitcoin-alpha, Email-Eu-core, Facebook, Brightkite, Gowalla, DBLP, Youtube, Orkut, LiveJournal) to evaluate the performance of the proposed methods. The datasets are public available1. Since the Exact algorithm is too slow, we only run Exact al- gorithm on Email-Eu-core and Bitcoin-alpha dataset. Since the properties of datasets are quite different, we set the default k as 10 for 4 datasets (Gowalla, Youtube, Brightkite, DBLP) and set the default k as 20 for 3 datasets (Facebook, LiveJournal, Orkut). We set default b as 5 for all datasets. All the programs are implemented in C++. All the experiments are performed on a machine with an Intel Xeon 2.20 GHz CPU and 128 GB memory running Linux. 5.2 Effectiveness Evaluation To evaluate the effectiveness of the proposed methods, we re- port the number of followers by deleting b edges. Since UP- Edge only accelerates the speed of Baseline and GP-Edge, we only report the results of UP-Edge here. Due to the huge time cost of Exact, we show the result on 3 datasets, that is, Bitcoin-alpha, Email-Eu-core and Artificial network (gener- ated by GTGraph with 500 nodes and 5000 edges). We set k = 11 and 8 for Bitcoin-alpha and Artificial net- work respectively, and vary b from 1 to 4. In Figure 3(a), we can see that there is only a slight drop when b=3. In Fig- ure 3(b), there is only a small drop when b=4. In Figure 3(c), as we can see, UP-Edge also shows comparable results with Exact and they all outperform Support significantly. Simi- lar results can be observed in Figure 3(d)-3(f) over all the datasets and the selected datasets. Figure 3(e) and 3(f) show the results on LiveJournal by varying b and k. As observed, the number of followers for the two algorithms are positive correlated with b, and k has a great impact on follower size. Figure 4 shows a case study on DBLP with k = 10, b = 1. We can see that the edge between Lynn A. Volk and David W. Bates is the most pivotal relationship. This edge has 264 followers (grey edges in the figure). It is interesting that most followers have no direct connection with them. 5.3 Efficiency Evaluation To evaluate the efficiency, we compare the response time of UP-Edge and GP-Edge with Baseline . We first conduct the experiments on all the datasets with default settings. Figure 5 shows the response time of the three algorithms. We can see that UP-Edge and GP-Edge significantly outperform Baseline in all the datasets because of the pruning techniques devel- oped. UP-Edge is faster than GP-Edge due to the contribution 1https://snap.stanford.edu/data/, https://dblp.org/xml/release/ (a) Bitcoin-alpha (k=11) (b) Artificial (k=8) Figure 5: Running time on all datasets (c) Email-Eu-core (b=2) (d) All datasets (e) LiveJournal (vary b) (f) LiveJournal (vary k) Figure 3: Effectiveness Evaluation Figure 4: Case study on DBLP, k=10, b=1 of upper bound derived. Figure 6 shows the results conducted on LiveJournal by varying b and k. We can see that when b grows, the response time increases since more edges need to be selected. When k grows, the response time decreases since the searching space becomes smaller. 6 Related Work Graph processing has been a hot topic in many areas recently, which usually requires much more computation comparing with some traditional queries [Luo et al., 2008; Wang et al., 2010; Wang et al., 2015]. Cohesive subgraph identification is of great importance to social network analysis. In the lit- erature, different definitions of cohesive subgraphs are pro- posed, such as k-core [Seidman, 1983; Wen et al., 2016], k- truss [Huang and Lakshmanan, 2017], clique [Tsourakakis et al., 2013], dense neighborhood graph [Kreutzer et al., 2018], etc. In the literature, numerous research is conducted to (a) LiveJournal (vary b) (b) LiveJournal (vary k) Figure 6: Efficiency Evaluation investigate the k-truss decomposition problem under differ- ent settings, including in-memory algorithms [Cohen, 2008], external-memory algorithms [Wang and Cheng, 2012], dis- tributed algorithms [Chen et al., 2014], etc. In some studies, authors leverage the k-truss property to mine required com- munities [Huang et al., 2014; Huang and Lakshmanan, 2017]. Huang et al. [Huang et al., 2016] investigate the truss de- composition problem in uncertain graphs. Recently, some re- search focuses on modifying the graph to maximize/minimize the corresponding metric [Bhawalkar et al., 2015; Zhang et al., 2017; Zhu et al., 2018; Medya et al., 2018]. Bhawalkar et al. [Bhawalkar et al., 2015] propose the anchored k-core problem, which tries to maximize the k-core by anchoring b nodes, while Zhang et al. [Zhang et al., 2017] and Zhu et al. [Zhu et al., 2018] investigate the problem of k-core mini- mization by deleting nodes and edges, respectively. In [Me- dya et al., 2018], Medya et al. try to maximize the node cen- trality by adding edges to the graph. However, these tech- niques cannot be extended for our problem. 7 Conclusion In this paper, we study the k-truss minimization problem. We first formally define the problem. Due to the hardness of the problem, a greedy baseline algorithm is proposed. To speed up the search, different pruning techniques are developed. In addition, an upper bound based strategy is presented by lever- aging the k-truss group concept. Lastly, we conduct extensive experiments on real-world social networks to demonstrate the advantage of the proposed techniques. References [Akbas and Zhao, 2017] Esra Akbas and Peixiang Zhao. Truss-based community search: a truss-equivalence based indexing approach. PVLDB, 10(11):1298 -- 1309, 2017. [Bhawalkar et al., 2015] Kshipra Bhawalkar, Jon Kleinberg, Kevin Lewi, Tim Roughgarden, and Aneesh Sharma. Pre- venting unraveling in social networks: the anchored k- 1234020406080FollowersExactUP-Edge1234050100150200FollowersExactUP-Edge48121620050100150200250FollowersExactUP-EdgeSupportBKGOYTDBFBORLJ101102103104FollowersUP-EdgeSupport123456789101102103FollowersUP-EdgeSupport202224262830323436101102103104FollowersUP-EdgeSupportBKGOYTFBDBLJOR100101102103104TimeCost(sec)UP-EdgeGP-EdgeBaseline123456789102103TimeCost(sec)UP-EdgeGP-EdgeBaseline202224262830323436102103TimeCost(sec)UP-EdgeGP-EdgeBaseline [Wen et al., 2016] Dong Wen, Lu Qin, Ying Zhang, Xuemin Lin, and Jeffrey Xu Yu. I/O efficient core graph decompo- sition at web scale. In ICDE, 2016. [Xiao et al., 2017] Di Xiao, Yi Cui, Daren BH Cline, and Dmitri Loguinov. On asymptotic cost of triangle listing in random graphs. In PODS, 2017. [Yu et al., 2013] Weiren Yu, Xuemin Lin, Wenjie Zhang, Li- jun Chang, and Jian Pei. More is simpler: Effectively and efficiently assessing node-pair similarities based on hyper- links. PVLDB, 7(1), 2013. [Zhang et al., 2017] Fan Zhang, Ying Zhang, Lu Qin, Wenjie Zhang, and Xuemin Lin. Finding critical users for social network engagement: The collapsed k-core problem. In AAAI, 2017. [Zhu et al., 2018] Weijie Zhu, Chen Chen, Xiaoyang Wang, and Xuemin Lin. K-core minimization: An edge manipu- lation approach. In CIKM, 2018. core problem. SIAM Journal on Discrete Mathematics, 29(3):1452 -- 1475, 2015. [Chen et al., 2014] Pei-Ling Chen, Chung-Kuang Chou, and Ming-Syan Chen. Distributed algorithms for k-truss de- In IEEE International Conference on Big composition. Data, 2014. [Cohen, 2008] Jonathan Cohen. Trusses: Cohesive sub- graphs for social network analysis. National Security Agency Technical Report, 2008. [Cui et al., 2018] Yi Cui, Di Xiao, and Dmitri Loguinov. On efficient external-memory triangle listing. TKDE, 2018. [Huang and Lakshmanan, 2017] Xin Huang and Laks V. S. Attribute-driven community search. Lakshmanan. PVLDB, 2017. [Huang et al., 2014] Xin Huang, Hong Cheng, Lu Qin, Wen- tao Tian, and Jeffrey Xu Yu. Querying k-truss community in large and dynamic graphs. In SIGMOD, pages 1311 -- 1322, 2014. [Huang et al., 2016] Xin Huang, Wei Lu, and Laks V.S. Lak- shmanan. Truss decomposition of probabilistic graphs: Semantics and algorithms. In SIGMOD, 2016. [Karp, 1972] Richard M. Karp. Reducibility among combi- natorial problems. In Complexity of Computer Computa- tions, pages 85 -- 103, 1972. [Kreutzer et al., 2018] Stephan Kreutzer, Roman Rabi- novich, and Sebastian Siebertz. Polynomial kernels and wideness properties of nowhere dense graph classes. ACM Trans. Algorithms, 15(2), 2018. [Luo et al., 2008] Yi Luo, Wei Wang, and Xuemin Lin. Spark: A keyword search engine on relational databases. In ICDE, 2008. [Medya et al., 2018] Sourav Medya, Arlei Silva, Ambuj Singh, Prithwish Basu, and Ananthram Swami. Group In ICDM, centrality maximization via network design. 2018. [Seidman, 1983] Stephen B. Seidman. Network structure and minimum degree. Social Networks, 5(3):269 -- 287, 1983. [Tsourakakis et al., 2013] Charalampos Tsourakakis, Francesco Bonchi, Aristides Gionis, Francesco Gullo, and Maria Tsiarli. Denser than the densest subgraph: extracting optimal quasi-cliques with quality guarantees. In KDD, 2013. [Wang and Cheng, 2012] Jia Wang and James Cheng. Truss decomposition in massive networks. Proc. VLDB Endow., 2012. [Wang et al., 2010] Chaokun Wang, Jianmin Wang, Xuemin Lin, Wei Wang, Haixun Wang, Hongsong Li, Wanpeng Tian, Jun Xu, and Rui Li. Mapdupreducer: detecting near duplicates over massive datasets. In SIGMOD, 2010. [Wang et al., 2015] Xiang Wang, Ying Zhang, Wenjie Zhang, Xuemin Lin, and Wei Wang. Ap-tree: Efficiently support continuous spatial-keyword queries over stream. In ICDE, 2015.
1505.07193
1
1505
2015-05-27T05:30:33
From Micro to Macro: Uncovering and Predicting Information Cascading Process with Behavioral Dynamics
[ "cs.SI", "physics.soc-ph" ]
Cascades are ubiquitous in various network environments. How to predict these cascades is highly nontrivial in several vital applications, such as viral marketing, epidemic prevention and traffic management. Most previous works mainly focus on predicting the final cascade sizes. As cascades are typical dynamic processes, it is always interesting and important to predict the cascade size at any time, or predict the time when a cascade will reach a certain size (e.g. an threshold for outbreak). In this paper, we unify all these tasks into a fundamental problem: cascading process prediction. That is, given the early stage of a cascade, how to predict its cumulative cascade size of any later time? For such a challenging problem, how to understand the micro mechanism that drives and generates the macro phenomenons (i.e. cascading proceese) is essential. Here we introduce behavioral dynamics as the micro mechanism to describe the dynamic process of a node's neighbors get infected by a cascade after this node get infected (i.e. one-hop subcascades). Through data-driven analysis, we find out the common principles and patterns lying in behavioral dynamics and propose a novel Networked Weibull Regression model for behavioral dynamics modeling. After that we propose a novel method for predicting cascading processes by effectively aggregating behavioral dynamics, and propose a scalable solution to approximate the cascading process with a theoretical guarantee. We extensively evaluate the proposed method on a large scale social network dataset. The results demonstrate that the proposed method can significantly outperform other state-of-the-art baselines in multiple tasks including cascade size prediction, outbreak time prediction and cascading process prediction.
cs.SI
cs
From Micro to Macro: Uncovering and Predicting Information Cascading Process with Behavioral Dynamics Linyun Yu1, Peng Cui1, Fei Wang2, Chaoming Song3, Shiqiang Yang1 1Department of Computer Science and Technology, Tsinghua University 2Department of Computer Science and Engineering, University of Connecticut [email protected],[email protected],[email protected] [email protected], [email protected] 3Department of Physics, University of Miami 5 1 0 2 y a M 7 2 ] I S . s c [ 1 v 3 9 1 7 0 . 5 0 5 1 : v i X r a ABSTRACT Cascades are ubiquitous in various network environments. How to predict these cascades is highly nontrivial in several vital applications, such as viral marketing, epidemic preven- tion and traffic management. Most previous works mainly focus on predicting the final cascade sizes. As cascades are typical dynamic processes, it is always interesting and im- portant to predict the cascade size at any time, or predict the time when a cascade will reach a certain size (e.g. an threshold for outbreak). In this paper, we unify all these tasks into a fundamental problem: cascading process predic- tion. That is, given the early stage of a cascade, how to pre- dict its cumulative cascade size of any later time? For such a challenging problem, how to understand the micro mech- anism that drives and generates the macro phenomenons (i.e. cascading proceese) is essential. Here we introduce be- havioral dynamics as the micro mechanism to describe the dynamic process of a node’s neighbors get infected by a cas- cade after this node get infected (i.e. one-hop subcascades). Through data-driven analysis, we find out the common prin- ciples and patterns lying in behavioral dynamics and propose a novel Networked Weibull Regression model for behavioral dynamics modeling. After that we propose a novel method for predicting cascading processes by effectively aggregat- ing behavioral dynamics, and propose a scalable solution to approximate the cascading process with a theoretical guar- antee. We extensively evaluate the proposed method on a large scale social network dataset. The results demonstrate that the proposed method can significantly outperform other state-of-the-art baselines in multiple tasks including cascade size prediction, outbreak time prediction and cascading pro- cess prediction. Keywords Information Cascades, Social Network, Dynamic Processes Prediction Permission to make digital or hard copies of all or part of this work for personal or classroom use is granted without fee provided that copies are not made or distributed for profit or commercial advantage and that copies bear this notice and the full citation on the first page. To copy otherwise, to republish, to post on servers or to redistribute to lists, requires prior specific permission and/or a fee. Copyright 20XX ACM X-XXXXX-XX-X/XX/XX ...$15.00. 1. INTRODUCTION In a network environment, if decentralized nodes act on the basis of how their neighbors act at earlier time, these local actions often lead to interesting macro dynamics - cas- cades. In online social networks, the information a user can get and engage in is highly dependent on what his/her friends share, and thus information cascades naturally occur and become the major mechanism for information commu- nication. There has been a growing body of research on these information cascades because of their big potential in various vital applications such as viral marketing, epidemic prevention, and traffic management. Most of them focus on characterizing these information cascades and discovering their patterns in structures, contents and temporal dynam- ics. Recently, predictive modeling on information cascades has aroused considerable research interests. Earlier works on predicting the final size of information cascades based on content, behavioral and structural features [3, 6]. As only large cascades are of interest in most real applications, Cui et al.[6] propose a data driven approach to predicting whether the final size will surpass a threshold for outbreak. More recently, Cheng et al.[3] go beyond the final size to contin- uously predict whether the cascade will double the current size in future. They also raise an interesting question that whether cascades can be predicted, and their experimental results demonstrate that cascade size are highly predictable. However, the previous works were all about cascade size, which did not include the whole of information cascades. Information cascade is a typical dynamic process, and tem- poral scale is critical for understanding the cascading mech- anism. Also, it is highly nontrivial to predict when a cascade breaks out, and, more ambitiously, to predict the evolving process of a cascade (i.e. cascading process, as shown in 1 (a)). In this paper, we move one step forward to ask: Is the cascading process predictable? That is, given the early stage of an information cascade, can we predict its cumula- tive cascade size of any later time? It is apparent that the targeted problem is far more chal- lenging than those in previous works. The commonly used cascade-level macro features for size prediction, such as the content, increasing speed and structures in the early stage are not distinctive and predictive enough for the cascade sizes at any later time. A fundamental way to address this problem is to look into the micro mechanism of cascading processes. Intuitively, an information cascading process can be decomposed into multiple local (one-hop) subcascades. Figure 1: Illustration of cascading process prediction When a node involves in a cascade, one or more of its off- spring nodes will also involve in the cascade with a tem- poral scaling. If the dynamic process of these subcasades can be accurately modeled, then the cascade process can be straightforwardly predicted by an additive function of these local subcascades. Here we exploit behavioral dynamics as the micro mech- anism to represent the above mentioned dynamic process of local subcascades. Given a node involving in a cascade at t0, its behavioral dynamic aims at capturing the chang- ing process of the cumulative number of its offspring nodes that involve in the cascade with time evolving. By defini- tion, this is a non-decreasing counting process and can be well represented by survival model [16]. A paucity of re- cent research works have exploited the survival theory to model how the occurrence of event at a node affects the time for its occurrence at other nodes (i.e. diffusion rate), and their results demonstrate the superiority of continuous- time survival model to uncover temporal processes. How- ever, their targeted problem is to uncover the hidden dif- fusion networks, and thus suppose the parameters of the survival function on each edge to be fixed. This will cause the unexpected result that all the cascades with the same root node (or early involved nodes) will be anticipated to have the same cascading processes, which makes these mod- els inapplicable in our problem. In this paper, we propose a novel method for cascading process prediction, as shown in Figure 1. Given the early stage of a cascading process before t in Figure 1 (a), we il- lustrate the partially observed cascade as shown in Figure 1 (b), where nodes in green (red) represent the observed (un- observed) nodes involved before (after) t. Given the behav- ioral dynamics of node p1 represented by its survival rates, and the number of its offspring nodes that have involved be- fore t, we can predict the cumulative number of its offspring nodes that involve in the cascade at any time t(cid:48) > t. Af- ter conducting similar predictions on all the observed nodes, the cascading process after t can be predicted by an additive function over all local predictions from behavioral dynamics. More specifically, how to model behavioral dynamics and further predict cascading process based on continuous-time survival theory also entail many challenges. First, it is un- clear what distribution form the behavioral dynamics fol- low. Although Exponential and Rayleigh distributions are commonly used to characterize the temporal scaling of pair- wise interactions, behavioral dynamics in this paper are a reflection of collective behaviors and are proved to be incon- sistent with these simple distributions in real data. Second, the parameters in survival models are difficult to interpret, which limits the generality of the learned model. Given the distribution form of data, the parameters of survival model can always be learned from real data in maximum likelihood manner. However, it is unsure what these parameters stands for and the learned model cannot be generalized to out-of- sample nodes (i.e. the nodes whose behavioral dynamic data is not included in the data). Third, the predictive models based on survival theory are computationally expensive due to the continuous-time characteristic, which makes them in- feasible in real applications. Thus, we intend to design an effective and interpretable model for behavioral dynamics modeling and a scalable solution for cascading process pre- diction. In particular, we conduct extensive statistical analysis on large scale real data and find that the behavioral dynamics cannot be well captured by simple distributions such as Ex- ponential and Rayleigh distribution, but the general form of Exponential and Rayleigh, Weibull distribution, can well preserve the characteristics of behavioral dynamics. Also, we discover strong correlations between the parameters of a node’s behavioral dynamics and its neighbor nodes be- havioral features. Enlightened by these, we propose a NEt- worked WEibull Regression (NEWER) model for parameter learning of behavioral dynamics. In addition to the maxi- mum likelihood estimation term, we also assume the param- eters of a node can be regressed by the behavioral features of its neighbor nodes and thus impose networked regular- izers to improve the interpretability and generality of the model. Based on the behavioral dynamics, we further pro- pose an additive model for cascading process prediction. To make it scalable, we propose an efficient sampling strategy for approximation with a theoretical guarantee. We extensively evaluate the proposed method in a com- plete dataset from a population-level social network in China, including over 320 million users, 1.2 billion edges and 340 million cascades . In all the testing scenarios, the proposed method can significantly outperform other baseline meth- ods. Figure 2 is a showcase of cascading process prediction by the proposed method. We show that by accurately mod- eling behavioral dynamics of social network users, we can predict the cascading process with a 2 hours leading time window, and get the average precision of 0.97 if we restrict the error rate of the size to be 0.1. Also, the accurate pre- dictions of final cascade size, cascade outbreaking time are all implied in the predicted cascading process. The main contributions of this paper are: (1) Enlightened by the cascading size prediction works, we Predictedcascading processEarlystage(a) Cascading Process(c) Behavioral dynamicsof 𝑝1(b) Partially observed cascade at t base on the information of other edges. Influence Modeling and Maximization. Influence mod- eling and maximization aims to evaluate users’ importance in social networks. This is first proposed by Domingos et al. [7] to select early starters to trigger a large cascade. Then Kempe et al. [12] proposed Stochastic Cascade Model to for- malize the problem and Chen et al. [2] proposed a scalable solutions. Recently the approach was extended to adding opinion effect [1, 9] or time decay effects [18] on the models. Our work is distinct from existing works in the following way: Rather than quantify the influence on nodes, we will predict the cascading process. 3. PRELIMINARIES This section presents the dataset information, discovered patterns and validated hypothesises to support the model design and solution. 3.1 Dataset Description The dataset in this paper is from Tencent Weibo, one of the largest Twitter-style websites in China. We collect all the cascades in 10 days generated between Nov 15th and Nov 25th in 2011. The dataset contains in total 320 mil- lion users with their social relations, 340 million cascades1 with their explicit cascading processes. The distribution of cascade size is shown in Figure 3. We can see that the cas- cade size follows Power-Law distribution, and the majority of cascades have very small size, which are not of interest for many applications. As the paper intends to predict cascad- ing process, we filter out the cascades with the size of less than 5, and maintain the remaining 0.59 million cascades with obvious cascading process for statistical analysis and experiments. Figure 3: Distribution of cascade size. The red straight line is the linear fitting result to the blue curve, showing the size distribution fits power-law. 3.2 Characteristics of Behavioral Dynamics As mentioned before, behavioral dynamics play a central role in uncovering and predicting cascade processes. Here we investigate the characteristics of behavioral dynamics to en- lighten the modeling of behavioral dynamics. By definition, the behavioral dynamics of a user capture the changing pro- cess of the cumulative number of his/her followers retweet 1Here the cascades are information cascades. When a user retweet/generate a post, several of his/her followers will fur- ther retweet the post and so on so forth to form a information cascade. Figure 2: Showcase of cascading process predic- tion for a real cascade. The red line represents the groundtruth cascading process. The others are pre- diction results based on different early stage infor- mation. move one step forward to attempt cascading process predic- tion problem, which implies several vital problems such as cascade size prediction, outbreaking time prediction as well as evolving process prediction. (2) We find out the common principles and patterns ly- ing in behavioral dynamics and propose a novel Networked Weibull Regression model for behavioral dynamics modeling accordingly, which significantly improves the interpretability and generality of traditional survival models. (3) We propose a novel method for predicting macro cas- cading process by aggregating micro behavioral dynamics, and propose a scalable solution to approximate the cascad- ing process with a theoretical guarantee. 2. RELATED WORK Prediction on Cascades. In recent years, many methods have been proposed to make prediction on cascades. Most of them focus on predicting the future size of a cascade, and the common way is to select vital nodes and place sensors on them. For example, Cohen et al. [4] focus on exploring the topological characteristics of the cascade. Cui et al. [6] pro- poses to optimize the size prediction problem using dynamic information. Cheng et al. [3] introduces temporal feature into the problem and they predict the growing size of the cascade. Rather than attempt to predict the cascade size, we focus on predicting the cascading process which considers both time and volume information together. Survival Model. Survival model is a method try to anal- ysis things according to the time duration until one or more events happen. In recent years, researchers started model- ing information diffusion using continuous models. Myers et al. [14] proposed CONNIE to infer the diffusion network base on convex programming while leaving the transmission rate to be fixed, later on Rodriguez et al.[17] proposed NE- TRATE which allowing the transmission rate to be different in different edges. Subsequently, Rodriguez et al. [10] give an additive model and a multiplicative model to describe information propagation base on survival theory. Most of these works focus on discovering the rules and patterns to the edges in the social network and is hard to extend to make predictions for cascades since the correlation between transmission rates on edges is little. In contrast, our work focus more on predictive modeling by grouping correlated edges together so that we can make predictions for edges Esp= 0.1Early stage Percentage=0.2Early stage Percentage=0.3Early stage Percentage=0.5δ0.2-Precision=0.52δ0.2-Precision=0.63δ0.2-Precision=0.85δ0.2-Precision=0.94`y=-1.66x+5.92 model Exponential Power Law Rayleigh Weibull density function λie−λit (cid:0) t (cid:1)−αi−1 (cid:17)ki−1 (cid:16) t t2 2 δ λi αite−αi αi δ ki λi −(cid:16) t λi e (cid:0) t (cid:1)−αi survival function e−λit (cid:17)ki −(cid:16) t e−αi e t2 2 λi δ (cid:17)ki hazard function λi αi t αit (cid:17)ki−1 (cid:16) t ki λi λi Table 1: Parametric Models ks-static in Weibo 0.2741 0.9893 0.7842 0.0738 (cid:80) the number of the posts user re- ceived in a certain period. the number of the posts user sent in a certain period. average inflow rate of fans to the user, or where i is the fans to the user(and the same as following). average retweet rate of fans to the i retweet(i)·retweet rate(i) user, or (cid:80) i retweet(i)·in f low(i) i retweet(i) (cid:80) (cid:80) i retweet(i) . Behavioral features inf low rate outf low rate f ollower avg− inf low rate f ollower avg− retweet rate Structural features f ollower number f ollow number a post after the user retweeting the post. Then the behav- ioral dynamics of a user can be straightforwardly represented by averaging the size growth curve of all subcascades that spread to the user and his/her followers. However, Figure 4 shows that the size growth curves vary significantly for dif- ferent subcascades of the same user, which means that such a representation is not fit to characterize behavioral dynam- ics. Here we normalize the size growth process by the cas- cade final size and adopt survival function to describe the behavioral dynamics where the survival rate represents the percentage of nodes that has not been but will be infected. As shown in Figure 4, a user’s survival function is quite stable for different subcascades although their size growth patterns vary. Figure 4: The size growth curves and their corre- sponding survival function for 3 users. Then can we use the behavioral dynamics represented by survival function to predict the size growth curve of a sub- cascade? We provide positive answer with the assistance of early stage information. For example, if we know the subcascade size at an early time t0, then the survival func- tion can be straightforwardly transformed from percentage dimension into size dimension. 3.3 Parametrize Behavioral Dynamics For the ease of computation and modeling, we need to parametrize the behavioral dynamics in our case. In state- of-the-art, Exponential and Rayleigh distributions are often used to describe the dynamics of user behaviors in different settings [8, 11]. Here we testify these distribution hypothesis on our real data and find that these distributions cannot well capture both the shape and scale characteristics of behav- ioral dynamics. Thus, we turn to the general form of Expo- nential and Rayleigh distributions, the Weibull distribution [15], and find it adequate for parametrizing behavioral dy- namics. In order to quantify the effect of parametrization, we calculate KS-Statistic for the three candidate distribu- tions as shown in Table 1. It displays that Weibull distribu- tion performs much better than Exponential and Rayleigh distribution. The improvement is attributed to the high degree of freedom of Weibull distribution as it has two pa- rameters λ and k to respectively control the scale and shape of the behavioral dynamics. 3.4 Covariates of Behavioral Dynamics If subcascades for all users are sufficient, the parameters of behavioral dynamics can be directly learned from data. number of the followers to the user. number of users this user follows. Table 2: Behavioral features for users. However this suffers from several drawbacks: (1) some users may have no or very sparse subcascade in training dataset, which makes these users’ behavioral dynamics inaccurate or even unknown; (2) it is difficult to interpret the param- eters directly learned from data, which prohibits us from getting insightful understanding on the behavioral dynam- ics. To address these, we investigate the covariates of be- havioral dynamics here. As the behavioral dynamics of a user are to capture the collective responses of his/her fol- lowers, we assume the parameters of the user’s behavioral dynamics should be correlated with the behavioral features of his/her followers (network neighbors). Hence, we extract a set of behavioral features for each user as listed in Table 2.2 For each user with enough subcascades in our dataset, we learned their λ and k directly from data. And then, we cal- culate the correlations between the learned parameters and their followers’ collective behavioral features. The examples given in Figure 5 indicate obvious correlations between the learned parameters with these behavioral features. There- fore, we can use these behavioral features as covariates to regress the parameters of behavioral dynamics. 3.5 From Behavioral Dynamics to Cascades After validating that the behavioral dynamics can poten- tially be accurately modeled and predicted, the key problem is whether we can derive the macro cascading process from micro behavioral dynamics. Intuitively, the cascading pro- cess cannot be perfectly predicted at early stage by behav- ioral dynamics. Given any time t, we can only use the behav- ioral dynamics of the users that involved before t to predict the cascading process after t. Consequently, the prediction coverage is restricted to all the followers of these users, while the users beyond this scope are neglected. These uncovered users may potentially affect the performance of cascading process prediction. 2We think that follower with different retweet number will have different effects to the user, so we modify the weights on each term of f ollower avg inf low rate and f ollower avg retweet rate. one node and spread (e.g., by retweeting) to its neighbor- ing nodes. A cascade is typically formed by repeating this process. Therefore, a cascade can be represented by a set of nodes C = {u1, u2, ...um}, where u1 is the root node. In a cascade, each node will get infected by the event only once, so it is tree-structured. For every node ui in the cascade, we denote its parent node as rp(ui). The time stamp that ui gets infected is t(ui), and t(ui) ≤ t(ui+1). Then the partial cascade before time t is denoted by Ct = {uit(ui) ≤ t}, and its size size(Ct) = Ct where . is the cardinality of a set. Then the cascade prediction problem can be defined as: Cascade Prediction: Given the early stage of a cascade Ct, predict the cascade size size(Ct(cid:48) ) with t(cid:48) ≥ t. 4.2 Survival Analysis Survival analysis is a branch of statistics that deals with analysis of time duration until one or more events happen, such as death in biological organisms and failure in mechan- ical systems [13]. It is a useful technique for cascade predic- tion. More concretely, let τ0 be a non-negative continuous random variable representing the waiting time until the oc- currence of an event with probability density funtion f (t), the survival function S(t) = P r{τ0 ≥ t} = f (t) (1) t encodes the probability that the event occurs after t, the hazard rate is defined as the event rate at time t condi- tional on survival until time t or later (τ0 ≥ t), i.e., λ(t) = lim dt→0 P r(t ≤ τ0 < t + dtτ0 ≥ t) dt = f (t) S(t) (2) S(t) and λ(t) are the two core quantities in survival anal- ysis. 4.3 NEtworked WEibull Regression Model The Weibull distribution is commonly used in survival analysis.In network scenario, if we think the time that an event (e.g., retweet) happened on a node as a survival pro- cess, we can fit a Weibull distribution to the survival time of node i, then its corresponding density, survival and hazard functions (cid:90) ∞ (cid:17)ki −(cid:16) t λi exp (cid:18) t (cid:19)ki−1 −(cid:16) t (cid:17)ki (cid:18) t (cid:19)ki−1 λi λi fi(t) = ki λi Si(t) = exp hi(t) = ki λi λi (3) (4) (5) where t > 0 is the average event happening time to node i, λi > 0 and ki > 0 is the scale and shape parameter of the Weibull distribution. In the following we will assume the network nodes are users and the event is retweeting. Likelihood of retweeting dynamics. Supposing there are N users in total, Ti is a set of mi time stamps and each element Ti,j indicates the j-th retweet time stamp to the post of the i-th user. We sort those time stamps out in increasing order so that Ti,j+1 (cid:62) Ti,j. We assume Ti,j ≥ 1 and Ti,mi > 1. Then the likelihood of the event data can be written as follows: Figure 5: Correlations between the survival function parameters and the behavioral features Fortunately, we observe two interesting phenomenons in real data. Minor dominance. Although each user has behavioral dynamics, the behavioral dynamics of different users make significantly different contributions to the cascading process. It is intuitive that the behavioral dynamics of an active user with 1 million followers contribute much more than that of an inactive user with 5 followers. The data also coincides with our intuition. According to Figure 6 (a), it can be observed that a very small number of nodes whose behav- ioral dynamics dominate the cascading process underpin the idea of just using the behavioral dynamics of these dominant nodes for cascading process prediction. Early stage dominance. Enlightened by the minor dominance phenomenon, we further ask whether the domi- nant nodes are prone to join cascades in early stage. Here, Figure 6 (b) depicts the time distribution of these dominant nodes joining in cascades, Figure 6: Minor dominance and early stage domi- nance in information cascades. Taking these two phenomena into account together, it is safe to design a model exploiting the behavioral dynamics of infected nodes in early stage to predict the cascading pro- cess. 4. METHODOLOGY This section introduces the NEtworked WEibull Regres- sion (NEWER) and cascade prediction methods in detail. 4.1 Problem Statement Given a network G = (cid:104)U, A(cid:105), where U is a collection of nodes and A is the set of pairwise directed/undirected re- lationships. An event (e.g., tweet) can be originated from L(λ, k) = = (hi(Ti,j) · Si(Ti,j)) ki · T ki−1 i,j · λ −ki i −T · e −ki i,j·λ ki i (cid:19) (6) (7) 4.4 Efficient cascading process prediction It should be born in mind that cascading prediction is intended to perform early prediction of its size at any later time. In the following we will present two models to achieve this goal. 4.4.1 Basic Model The entire flow of the basic model we proposed is illus- (cid:18) i=1 j=1 mi(cid:89) mi(cid:89) N(cid:89) N(cid:89) N(cid:88) (cid:80)mi j=1 i=1 log L(λ, k) = where li(λi, ki) = mi log ki + (ki − 1)(cid:80)mi li(λi, ki) i=1 j=1 log Ti,j− miki log λi − λ −ki i j=1 T ki i,j. As discovered in section 3.4, the survival characteristics of the user is correlated with the behavioral features of him/her. Then we can parametrize those parameters in the personalized Weibull distributions using those behav- ioral features. More formally, let xi be a r dimensional fea- ture vector for user i, we parameterize λi and ki with the following linear function: log λi = log xi ∗ β log ki = log xi ∗ γ (8) (9) where β and γ are r-dimensional parameter vector for λ and k. We attempt to find the scale and shape parameter of every user so that the likelihood of the observed data is maximized, at the same time we can also get the parameter vectors for out-of-sample extensions. We use the Equation (8) and (9) to replace λi and ki in the log likelihood function Equation (7) to solve the pa- rameters. To further enhance the interpretability, we also add (cid:96)1 sparsity regularizers on β and γ respectively to en- force model sparsity. Combining everything together, we can obtain the NEtworked WEibull Regression (NEWER) formulation which aims to minimize the following objective: F (λ, k, β, γ) = G1(λ, k) + µG2(β, λ) + ηG3(γ, k) G1(λ, k) = − log L(λ, k) G2(λ, β) = G3(k, γ) = 1 2N 1 2N (cid:107)log λ − log X · β(cid:107)2 + αβ (cid:107)β(cid:107)1 (cid:107)log k − log X · γ(cid:107)2 + αγ (cid:107)γ(cid:107)1 (10) (11) (12) (13) Optimization. To minimize F (λ, k, β, γ) in Equation (10), we first prove that the function is lower bounded. We have the following theorem. Theorem 1. F (λ, k, β, γ) has global minimum. Proof. See the appendix. With this theorem, the following coordinate descent strat- egy can be used to solve the problem with guaranteed con- vergence. At each iteration, we solve the problem with one group of variables with others fixed. F or it = 1, . . . , itmax λ[it+1] = argminλF (λ, k[it], β[it], γ[it]) k[it+1] = argminkF (λ[it+1], k, β[it], γ[it]) β[it+1] = argminβF (λ[it+1], k[it+1], β, γ[it]) γ[it+1] = argminγF (λ[it+1], k[it+1], β[it+1], γ) (14) For solving the subproblem with respect to λ or k, we use Newton’s Method. For subproblem with respect to β and γ, we use standard LASSO solver [19].  Set of users U involved in the cascade C before time tlimit, survival functions of users Suj (t), predicting time te; creates a subcascade process with replynum(ui) = 0 if ui is not root node then replynum(rp(ui)) = replynum(rp(ui)) + 1 trated in Algorithm 1: Algorithm 1 Basic Model Input: Size of cascade size (Cte ); Output: 1: for all user ui ∈ U do 2: 3: 4: 5: end if 6: end for 7: sum = 1 8: for all user ui ∈ U do 9: deathrate(ui) = max (cid:16) (cid:16) 1 − Sui (tlimit − t(ui)), 1V 1 − Sui (te − t(ui)), 1V (cid:17) (cid:17) 10: f drate(ui) = max sum = sum + replynum(ui)·f drate(ui) deathrate(ui) 11: 12: end for 13: return size (Cte ) = sum When a new node ui is added into the cascade at t(ui), the algorithm will launch a process to estimate the final size of the subcascade that ui will generate, with temporal size counter replynum(ui) and survival function Sui (t) starting at t(ui). If ui is involved by others, the algorithm also in- creases the temporal size of the retweet set of its parent rp(ui) by one. After all the information before the deadline is collected, the result will be finalized by aggregating all the value esti- mated by every subcascade process. Since the post number is at most V (all nodes in the network are involved into the cascade), the value of death rate deathrate(ui) and final death rate f drate(ui) (complement to their survival rates) at line 9 and line 10 is set to be 1/V when it is lower than 1/V . Complexity Analysis. Only constant time operations is involved in the two for-loops. Therefore, the complexity of the algorithm is O(n) where n is the number of users in the cascade. 4.4.2 Although the basic model solves the estimation problem, real applications often need to estimate the cascade size dy- namically so that the changes can be monitored. Sampling Model To make the algorithm scalable, the number of recalcu- lations should be limited, while the estimated value of size should fall into an acceptable error scope. We can utilize the following two facts to make the estimation process more efficient: (1) For a subcascade generated by ui, the esti- mation of the size will always be zero if there is no user involved into it, which means we can ignore the calculation. (2) If we do not re-estimate the final number of a subcascade (when there is no new user involved into it), the temporal size counter replynum(ui) and final death rate edrate(ui) will not change but the death rate deathrateui (t) will in- crease over time. Supposing the previous time stamp of the deathrateui (t1) subcascade set estimation is t0, it will cause a relative error deathrateui (t0) − 1 at t1. Hence, the relative error rate of rate will be at most  if we re-estimate the final number of u (1 − (1 + ) · (deathrateui (t0))). By the subcascade at S−1 exploring those two tricks, we propose a sampling model shown in Algorithm 2: Algorithm 2 Sampling Model Input: survival functions of users Suj (t), and set of users U in one cascade C(given dynamically); Output: for every size prediction request to te at t0, output size (Cte ); switch (request.type) 1: sum = 0; 2: while request = model.acceptRequest do 3: 4: 5: 6: 7: 8: ui=request.user, t0=request.time creates a subcascade process: return size (Cte ) = sum case APPROXIMATION: case INVOLVED USER: t(ui) = t0, app(ui) = 0, replynum(ui) = 0, f drate(ui) = max (cid:16) 1V , 1 − Srp(ui)(te − t0) (cid:17) ; if ui is root node then else sum = 1; trep = t0 − t (rp(ui)); replynum(rp(ui)) = replynum(rp(ui)) + 1; sum = sum − app(rp(ui)); deathrate(rp(ui)) = max app(rp(ui)) = replynum(rp(ui))·f drate(rp(ui)) sum = sum + app(rp(ui)); tnew = S−1 rp(ui)(1 − (1 + ) · deathrate(rp(ui))) (cid:16) 1V , 1 − Srp(ui)(trep) (cid:17) deathrate(rp(ui)) ; ; +t(rp(ui)); sendRequest(THRESHOLD CHANGE,rp(ui),tnew); end if case THRESHOLD CHANGE: (cid:16) 1V , 1 − Sui (t0 − t(ui)) (cid:17) ui = request.user, t0=request.time sum = sum − app(ui); deathrate(ui) = max ; tnew = S−1 ui (1 − (1 + ) · deathrate(ui)) + t(ui); sendRequest(THRESHOLD CHANGE,ui,tnew); app(ui) = replynum(ui)·f drate(ui) sum = sum + app(ui); deathrate(ui) ; 9: 10: 11: 12: 13: 14: 15: 16: 17: 18: 19: 20: 21: 22: 23: 24: 25: 26: 27: 28: 29: 30: end while end switch Complexity Analysis. The following theorem analyzes the complexity of Algorithm 2. Theorem 2. With an overall O(n log1+(V )) counting to estimate the number of subcascades, the sampling model can approximate the final size of the whole cascade at any time with an relative error rate of at most . Proof. For each approximation request, we only need to report the number directly; for every new subcascade, the initially operation number is also constant, and we need to do at most O(log1+(V )) times threshold adjustment for subcascade which has users involved in, since the lower- 1V and the upperbound is 1(all the bound of deathrate is people are involved in the cascade). Above all, the final com- plexity is O(t)+O(n)+O(n log1+(V )) = O(t+n log1+(V )) for each cascade (with n users and t requests). If we put this algorithm into an online environment, the complexity will be O(T + N log1+(V )) ∼ O(T ) for all the cascades with N Users in total3 (we see log1+(V ) as a constant with respect to T and N ∼ T as the number of users involved in cascades increases over time). With this model, for cascade final size prediction, we just need to set the prediction time te to be infinite so that the deathrate of all subcascades will be 1. For outbreak time prediction, we can make a binary search with respect to time te, checking whether the cascade size will be more or less than the size number at tmid and make the decision eachtime. 5. EXPERIMENTS In order to evaluate the performances and fully demon- strate the advantages of the proposed method, we conduct a series of experiments on the dataset introduced in Section 3.1. The results of multiple tasks are reported, including cascade size prediction, outbreak time prediction and cas- cading process prediction. Also, 5.1 Baselines and Evaluation Metrics Since we are the first to investigate cascading process pre- diction problem, no previous models can be adopted as di- rect baselines. Here, we implemented the following methods which can be potentially applied into our targeted problem as baselines: • Cox Proportional Hazard Regression Model (Cox) : This model assumes that the behavioral dynamics of all users have different scale parameters while sharing the same shape parameter. We use the same covariates as in our model and find the optimal scale parameters for all users and the shared shape parameter. We im- plement it as in [5]. • Exponential/Rayleigh Proportional Hazard Regression Model (Exponential/Rayleigh): Since the shape pa- rameters of both Exponential and Rayleigh distribu- tions are fixed values (1 for Exponential distribution and 2 for Rayleigh distribution), they are two special cases of Cox model. • Log-linear Regression Model (Log-linear): We refer to [3] which extracted 4 classes features to characterize cascades, including node features, structural features of cascades, temporal features and content features. In our case, we ignore the content features which are not covered in our dataset and also reported by [3] to be unimportant for cascade prediction. Then we use log-linear regression model to predict the cascade size. It is noted that Log-linear can only predict cascade size but not for time-related prediction, while Cox, Exponen- tial and Rayleigh models are applied to all prediction tasks. Also, the goal of Cox, Exponential and Rayleigh models are to elucidate the behavioral dynamics. After that, we use the same cascade prediction model as in our method to conduct cascade-level predictions. For each cascade, our dataset includes its complete cascad- ing process as the groundtruth. Next, we use the following metrics to evaluate the performances: 3It will be counted multiple times if a specific user involves in multiple cascades • Root Mean Square Log Error (RM SLE): In Power- Law distributed data, it is not reasonable to use stan- dard RMSE to evaluate the prediction accuracy. For example, for a cascade with the groundtruth size of 1000, it is significantly different to predict its size to be 2000 or 0, but they have the same RMSE. Thus, we first calculate the logarithmic results for both the groundtruth and predicted value, then calculate RMSE on the logarithmic results to evaluate the accuracy of the proposed method and baselines. • Precision with σ-Tolerance (δσ-Precision): In real ap- plications, a small deviation from the groundtruth value is often acceptable. In our case, we regard the pre- dicted value within the range of groundtruth(1 ± σ) as a correct prediction, and the resulted precision is δσ-Precision. For parameter setting, there are 4 parameters in our method, including µ, η, αβ and αγ. We tune these parameters by grid searching, and the optimal parameters used in our experi- ments are µ = 10, η = 10, αβ = 6 ∗ 10−5, αγ = 8 ∗ 10−6. 5.2 Cascade Size Prediction Figure 7: RM SLE results of different methods with different number of observed nodes in cascades. We randomly separate the cascades into 10 folds, and con- duct a 10-fold cross validation by using 9 of them as training data and the other one as testing data. For cascades with size over k, we use the first s(s < k) nodes as observed data, and the target is to predict the final cascade sizes. The prediction performances of all the methods are shown in Figure 7. It can be seen that the proposed method NEWER significantly outperforms other baselines in RM SLE value in different sized datasets. The baselines that has the clos- est performance with NEWER is the Cox model. We can see that the margins of improvement from Cox to NEWER are more obvious in the dataset with larger k. In a certain dataset, the margins are more evident with smaller s. These results demonstrate the significant advantage of NEWER in predicting large cascades in very early stage. Comparatively, the Log-linear method does not achieve satisfactory results in this task. The main reason is that the coefficients in the Log-linear model are highly biased to- wards the dominant number of small-sized cascades, which is also argued by [3]. In our method, we successfully overcome this bias by shifting from macro cascade level features to mi- cro behavioral dynamics. The substantial gain achieved by all behavioral dynamics based methods (including NEWER, Cox, Exponential and Rayleigh) exemplifies the importance of this micro mechanism for cascade prediction. In order to demonstrate the efficiency of the proposed method, we also evaluate the computational cost of NEWER and Sampling-NEWER in the computational environment with 3.4GHZ Quad Core Intel i7-3770 and 16GB memory. We track the process of all cascades. The base cascade pre- diction model (Base) re-predicts the final size at every time Improved Directed Model (δ = 0.1) Learning Method Base Model 8.47 ∗ 105s 7.61 ∗ 105s 6.65 ∗ 105s 4.35 ∗ 105s 3.4 ∗ 105s Method Size ≥ 20 Size ≥ 50 Size ≥ 100 Size ≥ 500 Size ≥ 1000 Table 3: Running time for different methods in dif- ferent dataset under a server with 3.4GHZ Quad Core Intel i7-3770 CPU and 16GB memory. 10.73s 8.62s 7.09s 4.33s 3.30s 899s 899s 898s 891s 881s points (in second), while the sampling-based cascade predic- tion model (Sampling) re-predicts the final size only when the observed cascade sizes increase. As shown in Table 3, the Sampling model (with a 10 percent performance degra- dation tolerance) is much more efficient than Base model by almost 5 magnitudes. According to Section 4.4, it is guaran- teed that the Sampling method can also improve with sim- ilar magnitudes than the Base model in cascading process prediction task. So we omit these results for brevity. 5.3 Outbreak Time Prediction Another interesting problem is to predict when a cascad- ing outbreak will happen. For example, in the early stage of a cascade, can we predict when the cascade reaches a spe- cific size? Without loss of generality, we set the outbreak size threshold to be 1000. We evaluate the prediction per- formance with different number of observed nodes in the cascades. As shown in Figure 8, the NEWER model get the best performances in both RM SLE and δσ-Precision metrics. Although Exponential and Rayleigh models report better results than NEWER in very early stage (less than 50 observation nodes), the improvements of their performances with increasing number of observed nodes are not as signif- icant as NEWER. Figure 8: Outbreak time prediction results of dif- ferent methods with different number of observed nodes in cascades. 5.4 Cascading Process Prediction The ultimate purpose of this paper is to predict the cas- cading process. For each cascade, we use δt to represent the early stage window and t to represent its ending time. Then we use the cascade information during [0, δt] to predict the cascading process during [δt, t]. At any time t ∈ [δt, t], we calculate whether the predicted cascade size at t is within the σ tolerance of the groundtruth size at t. Then we calculate the δσ-Precision by integrating t to describe the prediction accuracy for this cascading process. Finally, we average the δσ-Precision for all cascades and show the results in Fig- ure 9. Here, we vary the early stage percentage (i.e. δt/t) from 0 to 50%, and discover that in all the settings of early RMSLERMSLERMSLERMSLE stage percentage, NEWER always carries out the best per- formances in cascading process prediction. More over, the advantage of NEWER is more clear in smaller early stage percentage. When we set the early stage to be 15% of the whole cascade duration, we can get the δ0.2-Precision of 0.849. That means that we can correctly predict the cas- cade sizes at 84.9% time points, which indicates that the cascading process is predictable and the proposed method is adequate and superior in cascading process prediction. Fur- thermore, changing the precision tolerance value σ will not affect the relative results of all the methods in our experi- ments, and the precision value will be smaller when setting σ smaller. For abbreviation, we only report the results of σ = 0.2, which is a reasonable tolerance in most application scenarios. As shown in Figure 10, the NEWER model can signifi- cantly and consistently outperform Cox and Wbl models in out-of-sample prediction, which demonstrates that the dis- covered covariates from behavioral features of a user’s net- worked neighbors can effectively predict the user’s behav- ioral dynamics. Also, we visualize the regression coefficients β and γ in Figure 11. It can be observed that the behav- ioral features of a user’s followers plays more important roles in predicting both scale and shape parameters for the user, while the user’s structural features are less important. Figure 9: Cascading process prediction accuracy of different methods under different early stage per- centage settings. 5.5 Out-of-sample Prediction In real applications, the interaction information between nodes is not always available, which makes some nodes’ be- havioral dynamics cannot be directly derived by maximum likelihood estimation from data. We call these nodes as out- of-sample nodes. This is the main reason why we propose NEWER to incorporate the covariates of behavioral dynam- ics. In order to evaluate the performance of NEWER in handling this case, we simulate the scenario by hiding the interaction information of randomly selected 10% users as out-of-sample users, and then predict the final sizes of the cascades that these users involved in early stages. Figure 10: Prediction result by unknown users In Cox model, the scale parameters in behavioral dynam- ics of out-of-sample users can be regressed by the covariates. For the shape parameter, we calculate the average value of shape parameters in observed users and apply this value to the shape parameters of out-of-sample users. In NEWER model, both of shape and scale parameters can be regressed by covariates with the learned β and γ. We also employ the standard Weibull Regression (Wbl) as a basline, which can be derived by simply setting µ and η to be 0 in Equation 10. Then we use the averaged shape and scale parameters of observed users as the parameters of out-of-sample users. Figure 11: Parameter coefficients. 6. CONCLUSIONS In this paper, we raise an important and interesting ques- tion: beyond predicting the final size of a cascade, can we predict the whole cascading process if the early stage in- formation of cascades is given? In order to address this problem, we propose to uncover and predict the macro cas- cading process with micro behavioral dynamics. Through data-driven analysis, we find out the common principles and important patterns laying in behavioral dynamics, and pro- pose a novel NEWER model for behavioral dynamics mod- eling with good interpretability and generality. After that, we propose a scalable method to aggregate micro behavioral dynamics into macro cascading processes. Extensive exper- iments on a large scale real data set demonstrate that the proposed method achieves the best results in various cas- cading prediction tasks, including cascade size prediction, outbreak time prediction and cascading process prediction. Appendix: Proof of Theorem 1 Proof. It’s evident that both G2(β, λ) and G3(γ, k) has global minimum value. Next we prove that G1(λ, k) also has global min- imum value, or to prove log L(λ, k) has global maximum value. i(λ(cid:48) j=1 log Ti,j + mi log λ(cid:48) , log L(cid:48)(λ(cid:48), k) = log L(λ, k) = (cid:80)N i, ki) i − i=1 l(cid:48) −ki i Let λ(cid:48) where l(cid:48) λ(cid:48) i i, ki) = mi log ki + (ki − 1)(cid:80)mi (cid:80)mi i = λ i(λ(cid:48) i,j , the partial derivatives of the l(cid:48) j=1 T ki ∂l(cid:48) = − mi ∂λ(cid:48) λ(cid:48)2 mi(cid:88) ∂l(cid:48) i ∂ki ∂2l(cid:48) i ∂k2 i log Ti,j − λ(cid:48) mi(cid:88) mi(cid:88) mi(cid:88) = − mi k2 i − λ(cid:48) ∂2l(cid:48) ∂λ(cid:48)2 i mi ki T ki i,j , mi λ(cid:48) i − j=1 = i i = + j=1 i j=1 i i T ki i,j (log Ti,j )2 < 0 i j=1 i are given by: < 0 (15) T ki i,j log Ti,j (16) (17) Since ∂2l(cid:48) < 0 and ∂2l(cid:48) i ∂λ(cid:48)2 ∂k2 densities of parameters λ(cid:48) i i i < 0, the conditional marginal posterior i and ki are log-concave. Moreover, when NEWERRMSLERMSLERMSLEscaleshapeParameter coefficientParameter coefficient (cid:33) , (18) 1 j=1 Ti,j log Ti miT ki i,j = 0 ≥ mi + log Ti,j − 1 > 0 mi(cid:88) (cid:19) j=1 (cid:32) 0 < ki < 1, 0 < λ(cid:48) ∂l(cid:48) ∂λ(cid:48) mi λ(cid:48) − = i i i mi(cid:88) mi(cid:88) j=1 j=1 i , j=1 j=1 ki i,j ki i,j mi i < min i=1 T i=1 T i,j ≥ T ki T ki i,j log Ti,j (cid:80)mi −(cid:88) mi(cid:80)mi mi(cid:80)mi mi(cid:88) log Ti,j − λ(cid:48) (cid:80)mi (cid:80)mi (cid:80)mi j=1 Ti,j log Ti,j−(cid:80)mi −(cid:88) j=1 T ki i,j log Ti,j j=1 Ti,j log Ti (cid:33) λ(cid:48) mi 1, , i (cid:18) ki i,j log Ti,j − mi i,j ≤ T ki mi(cid:80)mi mi(cid:88) log Ti,j − λ(cid:48) i=1 T ki i,j i j=1 j=1 ∂l(cid:48) i ∂ki = mi ki ≥ mi ki + + mi(cid:88) j=1 (cid:32) 1, max when ki ≥ max mi(cid:80)mi mi(cid:88) j=1 T − mi(cid:88) ∂l(cid:48) ∂λ(cid:48) mi λ(cid:48) j=1 = i i i = + ∂l(cid:48) i ∂ki mi ki ≤ λ(cid:48) i = λ(cid:48) i mi mi j=1 Ti,j log Ti,j−(cid:80)mi (cid:80)mi mi(cid:88) mi(cid:88) Ti,j log Ti,j − j=1 log Ti,j log Ti,j + j=1 log Ti,j miT ki i,j = 0 j=1 and λ(cid:48) i ≥ (19) T ki i,j log Ti,j + mi(cid:88) mi(cid:88) j=1 mi(cid:88) log Ti,j − λ(cid:48) mi(cid:88) j=1 i log Ti,j − λ(cid:48) i T ki i,j log Ti,j T ki i,j log Ti,j j=1 j=1 j=1 j=1 < 0 which means there should be a global maximum of l(cid:48) log L. (20) i, so does 7. REFERENCES [1] W. Chen, A. Collins, R. Cummings, T. Ke, Z. Liu, D. Rincon, X. Sun, Y. Wang, W. Wei, and Y. Yuan. Influence maximization in social networks when negative opinions may emerge and propagate. In SDM, volume 11, pages 379–390. SIAM, 2011. [7] P. Domingos and M. Richardson. Mining the network value of customers. In Proceedings of the seventh ACM SIGKDD international conference on Knowledge discovery and data mining, pages 57–66. ACM, 2001. [8] N. Du, L. Song, H. Woo, and H. Zha. Uncover topic-sensitive information diffusion networks. In Proceedings of the Sixteenth International Conference on Artificial Intelligence and Statistics, pages 229–237, 2013. [9] A. Gionis, E. Terzi, and P. Tsaparas. Opinion maximization in social networks. arXiv preprint arXiv:1301.7455, 2013. [10] M. Gomez-Rodriguez, J. Leskovec, and B. Scholkopf. Modeling information propagation with survival theory. In ICML, 2013. [11] M. Gomez Rodriguez, J. Leskovec, and B. Scholkopf. Structure and dynamics of information pathways in online media. In Proceedings of the sixth ACM international conference on Web search and data mining, pages 23–32. ACM, 2013. [12] D. Kempe, J. Kleinberg, and ´E. Tardos. Maximizing the spread of influence through a social network. In Proceedings of the ninth ACM SIGKDD international conference on Knowledge discovery and data mining, pages 137–146. ACM, 2003. [13] R. G. Miller Jr. Survival analysis, volume 66. John Wiley & Sons, 2011. [14] S. Myers and J. Leskovec. On the convexity of latent social network inference. In Advances in Neural Information Processing Systems, pages 1741–1749, 2010. [15] J. E. Pinder III, J. G. Wiener, and M. H. Smith. The weibull distribution: a new method of summarizing survivorship data. Ecology, pages 175–179, 1978. [16] G. Rodriguez. Parametric survival models. Lectures Notes, Princeton University, 2005. [17] M. G. Rodriguez, D. Balduzzi, and B. Scholkopf. Uncovering the temporal dynamics of diffusion networks. arXiv preprint arXiv:1105.0697, 2011. [2] W. Chen, Y. Wang, and S. Yang. Efficient influence [18] M. G. Rodriguez and B. Scholkopf. Influence maximization in continuous time diffusion networks. arXiv preprint arXiv:1205.1682, 2012. [19] R. Tibshirani. Regression shrinkage and selection via the lasso. Journal of the Royal Statistical Society. Series B (Methodological), pages 267–288, 1996. maximization in social networks. In Proceedings of the 15th ACM SIGKDD international conference on Knowledge discovery and data mining, pages 199–208. ACM, 2009. [3] J. Cheng, L. Adamic, P. A. Dow, J. M. Kleinberg, and J. Leskovec. Can cascades be predicted? In Proceedings of the 23rd international conference on World wide web, pages 925–936. International World Wide Web Conferences Steering Committee, 2014. [4] R. Cohen, S. Havlin, and D. Ben-Avraham. Efficient immunization strategies for computer networks and populations. Physical review letters, 91(24):247901, 2003. [5] D. Cox. Regression models and life-tables. Journal of the Royal Statistical Society. Series B (Methodological), 34(2):187–220, 1972. [6] P. Cui, S. Jin, L. Yu, F. Wang, W. Zhu, and S. Yang. Cascading outbreak prediction in networks: a data-driven approach. In Proceedings of the 19th ACM SIGKDD international conference on Knowledge discovery and data mining, pages 901–909. ACM, 2013.
1908.06482
2
1908
2019-08-20T01:36:08
Scalable Explanation of Inferences on Large Graphs
[ "cs.SI", "cs.LG" ]
Probabilistic inferences distill knowledge from graphs to aid human make important decisions. Due to the inherent uncertainty in the model and the complexity of the knowledge, it is desirable to help the end-users understand the inference outcomes. Different from deep or high-dimensional parametric models, the lack of interpretability in graphical models is due to the cyclic and long-range dependencies and the byzantine inference procedures. Prior works did not tackle cycles and make \textit{the} inferences interpretable. To close the gap, we formulate the problem of explaining probabilistic inferences as a constrained cross-entropy minimization problem to find simple subgraphs that faithfully approximate the inferences to be explained. We prove that the optimization is NP-hard, while the objective is not monotonic and submodular to guarantee efficient greedy approximation. We propose a general beam search algorithm to find simple trees to enhance the interpretability and diversity in the explanations, with parallelization and a pruning strategy to allow efficient search on large and dense graphs without hurting faithfulness. We demonstrate superior performance on 10 networks from 4 distinct applications, comparing favorably to other explanation methods. Regarding the usability of the explanation, we visualize the explanation in an interface that allows the end-users to explore the diverse search results and find more personalized and sensible explanations.
cs.SI
cs
Scalable Explanation of Inferences on Large Graphs Chao Chen∗, Yifei Liu†, Xi Zhang†, Sihong Xie∗ ∗Department of Computer Science and Engineering, Lehigh University, Bethlehem, PA †Beijing University of Posts and Telecommunications, Beijing, China {chc517, six316}@lehigh.edu {liuyifei, zhangx}@bupt.edu.cn 9 1 0 2 g u A 0 2 ] I S . s c [ 2 v 2 8 4 6 0 . 8 0 9 1 : v i X r a Abstract -- Probabilistic inferences distill knowledge from graphs to aid human make important decisions. Due to the inher- ent uncertainty in the model and the complexity of the knowledge, it is desirable to help the end-users understand the inference outcomes. Different from deep or high-dimensional parametric models, the lack of interpretability in graphical models is due to the cyclic and long-range dependencies and the byzantine inference procedures. Prior works did not tackle cycles and make the inferences interpretable. To close the gap, we formulate the problem of explaining probabilistic inferences as a constrained cross-entropy minimization problem to find simple subgraphs that faithfully approximate the inferences to be explained. We prove that the optimization is NP-hard, while the objective is not monotonic and submodular to guarantee efficient greedy approximation. We propose a general beam search algorithm to find simple trees to enhance the interpretability and diversity in the explanations, with parallelization and a pruning strategy to allow efficient search on large and dense graphs without hurting faithfulness. We demonstrate superior performance on 10 networks from 4 distinct applications, comparing favorably to other explanation methods. Regarding the usability of the explanation, we visualize the explanation in an interface that allows the end-users to explore the diverse search results and find more personalized and sensible explanations. I. INTRODUCTION Distilling knowledge from graphs is an important task found ubiquitously in applications, such as fraud detection [34], user interest modeling in social networks [43, 44, 29], and bioinformatics [24, 14, 50]. The knowledge helps humans make high-stake decisions, such as whether to investigate a business or account for fraud detection on Yelp or to conduct expensive experiments on a promising protein in drug discovery. The state-of-the-art approaches model the graphs as directed or undirected graphical models, such as Bayesian networks, Markov Random Fields (MRF) [18], and Condi- tional Random Fields (CRF) [42], and distill knowledge from the graphs using inferences based on optimization [48, 12] and message passing [15]. Different from predictive models on i.i.d. vectors, graphical models capture the dependencies among random variables and carry more insights for decision making. However, the inferences involve iterative and recur- sive computations, making the inference outcomes cognitively difficult to understand, verify, and ratify, locking away more applications of graphical models (EU law requires algorithmic transparency [10]) and more accurate models through debug- ging [46]. We focus on MRFs and belief propagation (BP) inferences [20] that compute marginal distributions, aiming to make the inference outcomes more interpretable and thus Fig. 1. A cyclic graphical model G for the Zachary karate club network, with BP inference outcomes shown in two colors. We focus on explaining how BP calculates the belief on X, highlighted in the subgraph G(1). Due to the cycles and long-range dependencies on G, a complete explanation is recursive and long. With messages, beliefs, and priors, GraphExp extracts a limited-size tree G(3), on which X has a marginal similar to that on G. cognitively easier for humans. Fig. 1 depicts the problem definition and the proposed solution. Several challenges are due. First, simple but faithful ex- planations are desired [25] but have not been defined for inferences on MRFs. Prior work [13, 8] approximates a high- dimensional Gaussian through a sparse covariance matrix, which does not explain belief propagation. To explain the marginal distribution on MRFs, using sensitivity analysis, the authors in [5, 7] proposed to find influential parameters inher- ent in the model but not in any particular inference algorithms and computations. Explanation of parametric linear models and deep networks using surrogate models, differentiation, and feature selection [35, 19, 11, 26, 4] cannot be applied to graphical model inferences, although our proposal can explain inferences on deep graphical models [16]. Explainable RNNs [23] handles linear chains but not general MRFs. In terms of usability, previous works have studied how to visual- ize explanations of other models and utilize the explanations in the end tasks such as model debugging [40]. It is less know what's the best graph explanation complexity and faithfulness trade-off for the end-users, how to effectively communicate the probabilistic explanations, and how to utilize the explanations. Second, algorithmically, an MRF can be large, densely connected, and cyclic, while simple and faithful explanations need to be found efficiently. BP computes each message using other messages iteratively and recursively until convergence WZYX?WZYX?G(1)<latexit sha1_base64="(null)">(null)</latexit><latexit sha1_base64="(null)">(null)</latexit><latexit sha1_base64="(null)">(null)</latexit><latexit sha1_base64="(null)">(null)</latexit>G(3)<latexit sha1_base64="(null)">(null)</latexit><latexit sha1_base64="(null)">(null)</latexit><latexit sha1_base64="(null)">(null)</latexit><latexit sha1_base64="(null)">(null)</latexit>BP on Zachary karate club networkclass 1class 2The variable X tobe explained;contained in a cycleA variable 3 hops away (Eq. (2)). As a result, a message is a function of other mes- sages and a complete explanation requires the entire history of message computations, possibly from multiple iterations. Furthermore, on cyclic graphs, a converged message can be defined recursively by itself, generating explanations such as "a user is fraudulent because it is fraudulent". A desirable explanation should be without recursion, but cutting out the cycles may result in a different model and affect faithfulness. We propose a new approach called "GraphExp" to address the above challenges. Given the full graphical model G and any target variable X (the "explanandum") on G, GraphExp finds an "explanans" (or the "explaining") graphical model G consisting of a smaller number of random variables and dependencies. The goal of GraphExp is to minimize the loss in faithfulness measured by the symmetric KL-divergence between the marginals of X inferred on G and G [41]. Starting from the graph G(1) consisting of X only, GraphExp greedily includes the next best variable into the previous subgraph so that the enlarged subgraph has the lowest loss. Theoretically we prove that: (1) an exhaustive search for the optimal G with highest faithfulness (lowest loss) is NP-hard, and furthermore, the objective function is neither monotonic nor submodular, leading to the lack of a performance guarantee of any greedy approximation (Theorem II.1); (2) GraphExp only generates acyclic graphs that are more explainable (Theorem III.1). There can exist multiple sensible explanations for the same inference outcome [37, 36] and an end-user can find the one that best fits her mental model. We equip GraphExp with beam search [3] to discover a set of distinct, simple, and faithful explanations for a target variable. Regarding scalability, when looking for G on densely connected graphs, the branching factor in the search tree can be too large for fast search. While the search is trivially parallelizable, we further propose a safe pruning strategy that retains the desirable candidates while cutting the search space down significantly (Fig. 4). Regarding usability, GraphExp does not commit to a single explanation but allows the users to select one or multiple most sensible explanations for further investigation (Section IV-G). We highlight the contributions as follows: • We define the problem of explaining belief propagation to end-users and study the communication and utility of the explanations. • We propose an optimization problem for finding simple, faithful, and diverse explanations. We prove the hardness of the problem and then propose GraphExp as a greedy approximation algorithm to solve the problem. We analyze the time complexity and the properties of the output graphs, Both parallel search and the proposed pruning strategy deliver at least linear speed-up on large datasets. • Empirically, on 10 networks with up to millions of nodes and edges from 4 domains, GraphExp explains BP faith- fully and significantly outperforms variants of GraphExp and other explanation methods not designed for graphs. We propose visualization that allows flexible, intuitive of the found explanations. To demonstrate the utility of the found explanations, we identify a security issue in Yelp TABLE I Comparing GraphExp with prior explanation methods: FS (Feature Selection), LIME, GSparse (graph sparsification), and GDiff (graph differentiation). (∗: "surely yes"; ◦: "partially"; emptiness: "no"). ] 1 1 [ S F ] 5 3 [ E M I L ◦ ◦ ∗ ◦ ◦ ◦ TABLE II ] 8 [ e s r a p S G ∗ ◦ ◦ ] 5 [ f f i D G ∗ ∗ ◦ ◦ ◦ p x E h p a r G ∗ ∗ ∗ ∗ ∗ ∗ Notation Definitions Cycles handling Completeness Interpretability Diversity Scalability Flexibility Notation G = (V, E) V, E Xi, X, Y (xi, x, y) φX (x) (or φi(xi)) bX (x) (cid:44) P (X = x) ψXY (x, y) mX→Y (y) KL(pq) ∂G(cid:48) N (Xi) Definition Undirected graphical model (MRF) Random varaibles and their connections Random variables (and their values) Prior probability distribution of X (or Xi) Compatibility matrix between X and Y Message passed from X to Y Marginal distribution (belief) of X KL Divergence between p and q Variables in G \ G(cid:48) connected to subgraph G(cid:48) Neighbors of Xi on G spam detection using the found subgraphs. II. PROBLEM DEFINITION Notation definitions are summarized in Table II. Given a set of n random variables V = {X1, . . . , Xn}, each taking values in {1, . . . , c} where c is the number of classes, an MRF G factorizes the joint distribution P (V ) as (cid:89) i∈[n] P (V ) = 1 Z (cid:89) i,j∈[n] φi(Xi) ψij(Xi, Xj), (1) where Z normalizes the product to a probability distribution, φi is the prior distribution of Xi without considering other variables. The compatibility ψij(xi, xj) encodes how likely the pair (Xi, Xj) will take the value (xi, xj) jointly and capture the dependencies between variables. The factorization can be represented by a graph consisting of X1, . . . , Xn as nodes and edges (Xi, Xj), as shown in Fig. 1. BP inference computes the marginal distributions (beliefs) bX, X ∈ V , based on which human decisions can be made. The inference computes messages mi→j(xj) from Xi to Xj: ψij(xi, xj)φi(xi) (cid:88) xi 1 Zj (cid:89) mk→i(xi) (2) k∈N (Xi)\{j}  , where Zj is a normalization factor so that mi→j is a proba- bility distribution of xj. The messages in both directions on all edges (i, j) ∈ E are updated until convergence (guaranteed when G is acyclic [32]). The marginal bX is the belief b(X) ∝ φ(X) mY →X (X), (3) (cid:89) Y ∈N (X) where N (X) is the neighbors of X on G. We aim to explain is inferred by BP. For any X ∈ V , how the marginal bX depends on messages over all edges reachable from X and to completely explain how bX is computed, one has to trace down each message in Eq. (3) and Eq. (2). Such a complete explanation is hardly interpretable due to two factors: 1) on large graphs with long-range dependencies, messages and variables far away from X will contribute to bX indirectly through many steps; 2) when there is a cycle, BP needs multiple iterations to converge and a message can be recursively defined by itself [17, 15]. A complete explanation of BP can keep track of all these computations on a call graph [38]. However, the graph easily becomes too large to be intuitive for humans to interpret or analyze. Rather, bX should be approximated using short-range dependencies without iterative and recursive computations. The question is, without completely follow the original BP computations, how will the approximation affected? To answer this question, we formulate the following optimization problem: Definition 1. Given an MRF G, and a target node X ∈ V , extract another MRF G ⊂ G with X ∈ G and containing no more than C variables and no cycle, so that BP computes similar marginals bX and bX on G and G, respectively. Formally, solve the following d(bX , bX ) = KL(bXbX ) + KL(bXbX ) G acyclic. G≤ C, X ∈ G, min s.t. G ⊂ G, G (4) The objective captures the faithfulness of G, measured by the symmetric KL-divergence d between marginal distributions of X on G and G, where KL(PQ) = P (x) log[P (x)/Q(x)]. c(cid:88) (5) x=1 The choice of d as a faithfulness measured can be justified: KL(bXbX ) measures the loss when the "true" distribution is bX while the explaining distribution is bX [41]. Symmetrically, a user can regard bX as the "true" marginal, which can be explained by the bX. The simplicity of G can be measured by the number of variables on G, and for G to be interpretable, we control the size of G to be less than C. Since a graphical model encodes a joint distribution of a set of variables, the above problem is equivalent to searching a joint distribution of a smaller number of variables with fewer variable dependencies, so that the two joint distributions lead to similar marginals of the variable X to be explained. If the negation of the above objective function is submodular and monotonically increasing, then a greedy algorithm that iteratively builds G by adding one variable at a time to in- crease the negation of objective function (namely, to decrease d(bX , bX )) can generate a solution whose value is within (1 − 1/e) of the optimum [30]. Definition II.1 (Submodularity). Let V be a set and 2V be the power set of V. A set function f : 2V → R is submodular Fig. 2. A graphical model on which submodularity and monotonicity of the objective function in Eq. (4) do not hold. The goal is to find the best subgraph from {G0, G1, G2} that best approximates the belief of X inferred on G. Edges and nodes in red are those included in the individual subgraphs. if ∀A ⊂ A(cid:48) ⊂ V and any Y (cid:54)∈ A(cid:48), f (A ∪ {Y }) − f (A) ≥ f (A(cid:48) ∪ {Y }) − f (A(cid:48)). Definition II.2. A set function f : 2V → R is monotonically increasing if ∀A ⊂ A(cid:48) ⊂ V, implies f (A) ≤ f (A(cid:48)). However, we prove that both properties do not hold on d(bX , bX ), which cannot be efficiently approximated well. Theorem II.1. The objective function in Eq. (4) is not sub- modular nor monotonically increasing. Proof. We find a counterexample that violates submodularity and monotonicity. As shown in Fig. 2, the full graph G has 3 variables X, Y and Z, with X connected to Y and Z, respec- tively. The priors are φ(X) = [0.5, 0.5], φ(Y ) = [0.8, 0.2], and φ(Z) = [0.1, 0.9], and both edges have the same homophily- encouraging potential ψij(a, b) = 0.99 if a = b and 0.01 otherwise. Let subgraphs G0 = {X}, G1 = {X, Z} and G2 = {X, Y } be as shown in the figure. One can run BP on Gi, i = 0, 1, 2 to find bX and that (−dG2(bX , bX )) − (−dG0(bX , bX )) < (−dG(bX , bX )) − (−dG1(bX , bX )), with the subscriptions Gi indicating on which subgraph is bX computed. However, G0 ⊂ G1 and the gain through adding Y to G1 is greater than that adding Y to G0. On the same example, we can see that adding Y to G0 can increase the objective. III. METHODOLOGIES The optimization problem Eq. (4) can be solved by exhaus- tive search in the space of all possible trees under the specified constraints and it is thus a combinatorial subset maximization problem and NP-hard [11, 1], similar to exhaustive feature selection. Greedy algorithms are a common solution to ap- proximately solve NP-hard problems. Since finding multiple alternative sensible explanations is one of our goals, we adopt beam search in the greedy search [3], maintaining in a beam several top candidates ranked by faithfulness and succinctness throughout the search. A general greedy beam search framework is presented in Algorithm 1. The algorithm finds multiple explaining sub- graphs G(C) of size C in C − 1 iterations, where C is the maximum subgraph size (which roughly equals to human working memory capacity [28], or the number of cognitive YZXYZXG1<latexit sha1_base64="(null)">(null)</latexit><latexit sha1_base64="(null)">(null)</latexit><latexit sha1_base64="(null)">(null)</latexit><latexit sha1_base64="(null)">(null)</latexit>G0<latexit sha1_base64="(null)">(null)</latexit><latexit sha1_base64="(null)">(null)</latexit><latexit sha1_base64="(null)">(null)</latexit><latexit sha1_base64="(null)">(null)</latexit>YZXYZXX=[0.5,0.5]<latexit sha1_base64="(null)">(null)</latexit><latexit sha1_base64="(null)">(null)</latexit><latexit sha1_base64="(null)">(null)</latexit><latexit sha1_base64="(null)">(null)</latexit>Z=[0.1,0.9]<latexit sha1_base64="(null)">(null)</latexit><latexit sha1_base64="(null)">(null)</latexit><latexit sha1_base64="(null)">(null)</latexit><latexit sha1_base64="(null)">(null)</latexit>Y=[0.8,0.2]<latexit sha1_base64="(null)">(null)</latexit><latexit sha1_base64="(null)">(null)</latexit><latexit sha1_base64="(null)">(null)</latexit><latexit sha1_base64="(null)">(null)</latexit>Graphical modelparametersbX=[0.11,0.89]<latexit sha1_base64="(null)">(null)</latexit><latexit sha1_base64="(null)">(null)</latexit><latexit sha1_base64="(null)">(null)</latexit><latexit sha1_base64="(null)">(null)</latexit>bX=[0.5,0.5]<latexit sha1_base64="(null)">(null)</latexit><latexit sha1_base64="(null)">(null)</latexit><latexit sha1_base64="(null)">(null)</latexit><latexit sha1_base64="(null)">(null)</latexit>bX=[0.79,0.21]<latexit sha1_base64="(null)">(null)</latexit><latexit sha1_base64="(null)">(null)</latexit><latexit sha1_base64="(null)">(null)</latexit><latexit sha1_base64="(null)">(null)</latexit> Algorithm 1 GraphExp (the general search framework) Input:a graphical model G = (V, E); a target random variable X ∈ V to be explained; prior φi and belief bi, ∀Xi ∈ V ; messages mi→j for ∀(Xi, Xj) ∈ E; maximum subgraph complexity C; beam size k. Output: Multiple explaining subgraphs G for X, along with approximated computations of bX. Init: G(1) = ( V , E), V = {X}, E = ∅. Beam[1]={ G(1)} for t = 2 → C do Beam[t]= ∅. for each subgraph G(t−1) in Beam[t-1] do Find and add the top k extensions of G(t−1) Beam[t]. to end for Retain the top k candidates in Beam[t]. end for Run BP on each candidate graph in Beam[C] and obtain converged messages and beliefs as an approximation of computation of bX on G. chunks [22]). Starting from the initial G(1) = {X}, at each step t the graph G(t−1) is extended to G(t) by adding one more explaining node and edge to optimize a certain objective function without forming a loop. After the desired subgraphs are found and right before the algorithm exits, BP will be run again on G to compute bX so that we can use the converged messages on G to explain to an end-user how bX is approximated on G. Since G is small and contains no cycle, the explanation is significantly simpler than the original computations on G. We substantiate the general framework in the following two sections, with two alternative ways to rank candidate extensions of the subgraphs during the beam search. Before we discuss the two concrete algorithms, a theoretical aspect related to interpretability is characterized below. Theorem III.1. The output G from Algorithm 1 is a tree. Proof. We prove this by induction. Base case: G(0) is a single node so it is a tree. Inductive step: Assume that G(t) is a tree. By adding one more variable and edge (X∗ and e∗) to G(t), there is no cycle created, since we are only attaching X∗ to G(t) through a single edge e∗. A. GraphExp-Global (GE-G): search explanations via evalu- ating entire subgraphs We propose GE-G, an instantiation of Algorithm 1. At iteration t (t = 2, . . . , C), the algorithm evaluates the candi- date extensions of G(t−1) using the objective Eq. (4). Define ∂ G(t−1) be the set of nodes in G \ G(t−1) that are connected to G(t−1). A candidate G(t) is generated by adding a variable Y ∈ ∂ G(t−1) through the edge (Y, W ) to G(t−1), where W is a random variable in G(t−1). A new BP procedure is run on G(t) to infer bX, the marginal of X, and the distance Fig. 3. Explaining BP on a graphical model with four variables (X, Y , Z, and W ), four edges, and a cycle. We show one step of beam search, extending a candidate G(2) in Beam[2] to three candidates of G(3) in Beam[3] (with beam size 3). The rightmost candidate in Beam[2] is also extended but the extensions are not shown to avoid clutters. After all extensions are generated, only the top 3 are kept in Beam[3]. The edges and variables in red are included in the explaining subgraphs. Note that GE-G and GE-L have different behaviors when dealing with the extensions. d(bX , bX ) is calculated as the quality of the candidate G(t). After exhausting all possible candidates, GE-G adds the k candidates with the least distances to Beam[t]. One search step in Fig. 3 demonstrates the above ideas. The search attempts to extend the middle G(2) in Beam[2] by adding a new variable from ∂ G(2) = {Y, Z} to the subgraph, so the new belief bX on the larger subgraph is closer to bX. In this example, GE-G keeps the top 3 extensions of G(2) (beam size is 3), but only two options are legitimate and are the only two candidates included in Beam[3]. The middle subgraph consisting of {W, X} is generated by the algorithm GE-L to be discussed later (see Section III-C). When the search extends the bottom right subgraph G(3), variable Y ∈ ∂ G(3) can be connected to G(3) in two ways, through edges Y → Z and Y → W , but both GraphExp variants include only one link to avoid cycles in the exlaining subgraphs. On the high-level, GE-G is similar to forward wrapper-style feature selection algorithms, where each feature is evaluated by including it to the set of selected features and running a target classification model on the new feature sets. The key difference here is that GE-G can't select any variable on G, but has to restrict itself to those that will result in an acyclic graph (which is guaranteed by Theorem III.1). One of the advantages of GE-G is that the objective function in the optimization problem Eq. (4) is minimized directly at each greedy step. However, as each candidate at each step requires a separate BP, it can be time-consuming. We analyze the time complexity below. To generate a subgraph of maximum size C for a variable, C − 1 iterations are needed. At iteration t = 2, . . . , C, one has to run BP for as many times as the number of neighboring nodes of the current explanation G(t−1). The number of candidates that need to WZYX ?WZYX ?WZYX ?WZYX ?WZYX ?WZYX ?The prior of W bestexplains belief of W(GE-L stops expandingthis branch).New variable Y is added.New variable Z is added(only GE-G will generatethis branch)G(1)<latexit sha1_base64="(null)">(null)</latexit><latexit sha1_base64="(null)">(null)</latexit><latexit sha1_base64="(null)">(null)</latexit><latexit sha1_base64="(null)">(null)</latexit>Beam[2]Beam[3]GE-L and GE-GGE-L onlyGE-G only be evaluated for one of the k candidates in Beam[t-1] in the iteration equals the size of the number of neighboring nodes in ∂ G(t−1). On graphs with a small diameter, this size grows quickly to the number of nodes in G. On the other extreme, if G is a linear chain, this size is no more than 2. For each BP run, it is known that BP will converge in the number of iterations same as the diameter of the graph that BP is operated on, which is upper-bounded by the size of the candidate subgraph G(t). During each BP iteration, O(t) messages have to be computed. The overall time complexity t=2∂ G(t−1)t2), where k is the beam size. Since the number of classes on the variables are fixed and usually small (relative to the graph size), here we ignore the factor O(c2), which is the time complexity to compute one message. of GE-G is O(V k(cid:80)C B. Speeding up GE-G on large graphs Graphical models in real-world applications are usually gigantic containing tens or hundreds of thousands of nodes. GraphExp can take a long time to finish on such large graphs, especially when the graph diameter is small. Slowness can harm the usability of GraphExp in applications requiring interpretability, for example, when a user wants to inspect multiple explanations of BP for counterfactual analysis, or statistics of the errors needs to be computed over explanations of many nodes [46]. We propose parallelized search and a pruning strategy to speed up GE-G. Parallel search The general GraphExp algorithm can be parallelized on two levels. First, the generation of explanations over multiple target variables can be executed on multiple cores. Second, in the evaluation of the next extensions of G(t−1) during beam search, multiple candidates G(t) can be tried out at the same time on multiple cores. Particularly for GE-G, during the BP inference over each candidate G(t), there are existing parallel algorithms that compute the messages [9] asynchronously. As the subgraphs G(t) are bounded by the human cognitive capacity and are small, a parallel inference can be an overkill. We evaluate the reduction in search time using the first level of parallelism (Section IV-E). Pruning candidate variables In Algorithm 1, all candidates e ∈ C = (G \ ∂ G(t), ∂ G(t)) have to be evaluated to select (X∗, e∗) and we have to run BP as many times as C. When the cut C is large, this can be costly. As we aim at explaining how BP infers the marginal of the target Y , adding any variable that has a distribution that deviates much from the distribution of Y is not helpful but confusing. Considering that a subgraph G(t−1) has C candidates at step-t, we run BP on these C candidates and abandon the bottom (100− p) percent of them based on Eq. 4 in the following steps. C. GraphExp-Local (GE-L): search explanations via local message back-tracing Sometimes one may want to trade explanation faithful- ness for speed during subgraph search. For example, in the exploratory phase, a user wants to get a quick feeling of how the inferences are made or to identify mistakes caused by glitches on the graph before digging deeper into finer- grained explanations. We propose GE-L for this purpose to complement GE-G that can generate more faithful and detailed explanations (with the expense of more searching time). GE-L is based on message back-tracing that follows the general beam search but with more constraints on the search space. At iteration t, the search adds an additional edge between G(t−1) and ∂ G(t−1) that best explains a message or a belief in G(t−1), which can be computed using information that is not currently in G(t−1). There are two cases. • For a message mY →W on an edge (Y, W ) already included in G(t−1), the search attempts to find a message mZ→Y , where Z ∈ ∂ G(t−1), so that the message mZ→Y contributes most to the message mY →W . We use the distance d defined in Eq. (4) to measure the contribution of mZ→Y to mY →W : the smaller the distance, the more similar two messages are and thus more contribution from mZ→Y to mY →W . • For the belief bX of the target node X, the search attempts to find a message mW→X that best explains bX, using the distance between mW→X and bX. In both cases, we define the end points of G(t−1) as those nodes that are in G(t−1) but can be connected to those in ∂ G(t−1). In the example in Fig. 1, Y and X are end points of the subgraph G(2) in the middle. In GE-L, if the prior of an end-point best explains the message emitting from the end-point (e.g., mY →X in Fig. 1) or belief of the end-point (bX in the same figure), the prior is added to the subgraph and no extension can be made to the end point: the prior is a parameter of the graphical model and not computed by BP, and no other BP distribution can further explain the prior. The search of GE-L will stop at this branch, although the other branches in the beam can further be extended. Using the same example in Fig. 1, the prior φW best explains mW→X) and this branch is considered finished requiring no more extension. Analysis of GE-L We analyze what the above search is optimizing. We unify the two cases where the search explains how a message and belief are computed. Assuming that the potential function ψij for all edges (Xi, Xj) are identity matrices, which is the case when a graph exhibits strong homophily. Then the message going from Xi to Xj in Eq. (2) is proportional to (cid:89) φi(xi) mk→i(xi), (6) k∈N (Xi)\{j} in the form of P (x) =(cid:81)L factors in the product. Let Q =(cid:81)M which is in the same form of Eq. (3) when a belief is computed. Therefore, both messages and beliefs can be written (cid:96)=1 p(cid:96)(x), where L is the number of m=1 qm(x) be a distribution that explains P with M factors and with X being an end-point to be explained. If Q = P , then the distance is 0 but many edges (factors) are included in G. Starting from a uniform distribution, the search each time finds an approximating distribution Q(x) by including an additional factor in P to minimize d(P, Q) over all distributions P representing the so-far included messages and beliefs computed by BP on G, and over all factors (messages or priors) that have not been included but are contributing to P . Therefore, the algorithm does not directly attempt to optimize the objective d(bX , bX ) for the target X, but does so locally: it keeps adding more factors to best explain one of the next end-points, which can already explain the target variable to some extent. Variants of GE-L To further speed up GE-L (see Fig. 4), especially on graphs that a user has prior knowledge about the topology of the explaining subgraph, its search space can be further constrained. On the one hand, we can only extend a candidate on the end-point that is added most recently, creating a chain of variables so that one is explaining the other. This aligns with the conclusion that causal explanations are easier to be understood by the end-users [25], and our explanations of the inference are indeed causal: how bX is computed by a smaller subgraph will be presented to the end-users. On the other hand, when a target variable has many incoming messages (which is the case on social and scientific networks), it is best to spend the explaining capacity on direct neighbors. In the experiments, we adopt these two constraints over GE-L on the review and remaining networks, respectively. IV. EXPERIMENTS In this section, we examine the explanation faithfulness and interpretability of GE-L, GE-G, and the state-of-the-art baselines, including LIME, in ten different networks from four domains (spam detection, citation analysis, social networks, bioinformatics). We also evaluate the scalability and sensitivity analysis of these methods. Moreover, we conduct user study to demostrate the usability of GE-G. A. Datasets We drew datasets from four applications. First, we adopt the same three Yelp review networks (YelpChi, YelpNYC, and YelpZip) from [34] for spam detection tasks. We repre- sent reviewers, reviews, and products and their relationships (reviewer-review and review-product connections) by an MRF. BP can infer the labels (suspicious or normal) of reviews on the MRF given no labeled data but just prior suspicious- ness probability computed from meta-data [34]. Second, in collective classification, we construct an MRF for each one of three citation networks (Cora, Citeseer, and PubMed) that contain papers as nodes and undirected edges as paper citation relationships [29]. As a transductive learning algorithm, BP can infer the distributions of paper topics of an unlabeled paper, given labeled nodes in the same network. Third, we represent blogs (BlogCatalog), videos (Youtube), and users (Flickr) as nodes and behaviors including subscription and tagging as edges [43]. BP infers the preferences of users. The goal is to classify social network nodes into multiple classes. Lastly, in biological networks, we adopt the networks analyzed in [50] which denotes nodes as protein-protein pairs and the subordination relations of protein pair as the class. Explaining BP inference is important in all these applications: the MRFs are in general large and cyclic for a user to thoroughly inspect Ten networks from four application domains. TABLE III Edges edge/node Nodes 105,659 520,200 873,919 2,708 3,321 1,9717 269,580 1436,208 2434,392 10,556 9,196 44,324 1,138,499 10,312 80,513 2,990,443 333,983 5,899,882 13,682 287,916 Datasets YelpChi YelpNYC YelpZip Cora Citeseer PubMed Youtube BlogCatalog Flickr Bioinformatics Classes 2 2 2 7 6 3 47 39 195 144 2.55 2.76 2.79 3.90 2.78 2.25 2.63 32.39 73.28 21.04 why a paper belongs to a certain area, or why a review is suspicious, or why a blog is under a specific topic, or why two proteins connect to each other. It is much easier for the user to verify the inference outcome on much smaller explaining graphs. The statistics of the datasets are shown in Table III. B. Experimental setting On Yelp review networks, a review has two and only two neighbors (a reviewer posts the review and the product receives the review), while a reviewer and a product can be connected to multiple reviews. On the remaining networks, nodes are connected to other nodes without constraints of the number of neighbors and the type of nodes. We apply the two variants of GE-L on Yelp and other networks, respectively. Psychology study shows that human beings can process about seven items at a time [28]. To balance the faithfulness and interpretability, both GE-L and GE-G search subgraphs that are of maximum size five starting from the target node. In the demon, we explore larger explaining subgraphs to allow users to select the smallest subgraph that makes the most sense. On all ten networks, we assume homophily relationships between any pair of nodes. For example, a paper is more likely to be on the same topic of the neighboring paper, and two nodes are more likely to be suspicious or normal at the same time. On Yelp, we set node priors and compatibility matrices according to [34]. On other networks, we assign c−1 to the rest of the compatibility 0.9 to the diagonal and 0.1 metrics. As for priors, we assign 0.9 to the true class of a labeled node, and 0.1 c−1 to the remaining classes, where c is the number of classes in data. For unlabeled nodes, we set uniform distribution over classes. On Yelp, there is no labeled node, and on Youtube network, 5% are labeled nodes. For the remaining networks, we set the ratio of labeled data as 50%. With consideration the size of the large networks, we sample 1% from the unlabeled nodes as target nodes on Youtube and Flickr datasets, and sample 20% of unlabeled nodes as target nodes on BlogCatalog and Bioinformatics networks. C. Baselines Random It ignores the messages computed by BP and selects a node in ∂ G(t−1) randomly when extending G(t−1). Overall performance: in general Comb is the best method that significantly outperforms all other methods on all networks. We use • to indicate whether statistically GE-L significantly (pairwise t-test at 5% significance level) outperforms Random and whether Comb outperforms GE-G (k=3), respectively. TABLE IV Method Chi NYC Zip Cora Citeseer PubMed Youtube Flickr BlogCatalog Embedding 0.058[5.0] 0.084[5.0] 0.084[5.0] 0.527[4.8] 0.305[4.4] 0.842[5.0] 0.340[5.0] 5.903[5.0] 7.887[5.0] Bioinformatics 2.065[5.0] LIME 5.300 5.955 6.036 1.321 1.221 0.910 - - - - Random 0.053[3.9]• 0.043[4.1]• 0.040[4.2]• 0.362[3.6]• 0.243[2.9]• 0.718[3.1] 0.376[2.8] 6.259[4.7] 7.899[4.8] GE-L 0.036[3.9] 0.028[4.1] 0.025[4.2] 0.181[3.6] 0.108[2.9] 0.577[3.1] 0.321[2.8] 6.232[4.7] 8.054[4.8] Random 0.022[5.0] 0.017[5.0] 0.010[5.0] 0.594[4.8] 0.340[4.4] 0.893[5.0] 0.343[5.0] 6.018[5.0] 7.867[5.0] GE-G (k=1) GE-G (k=3) 0.0012[5.0]• 0.0012[5.0] 0.0011[5.0]• 0.0012[5.0] 0.0013[5.0]• 0.0014[5.0] 0.132[4.9]• 0.075[4.4]• 0.185[5.0]• 0.137[4.8] 0.077[4.4] 0.188[5.0] 0.263[5.0] 4.654[5.0] 6.621[5.0] 0.264[5.0] 4.652[5.0] 6.702[5.0] 2.085[4.9] 1.893[4.9] 2.116[5.0] 1.423[5.0] 1.508[5.0] Comb 0.0006[6.5] 0.0006[6.2] 0.0008[6.1] 0.084[6.4] 0.048[5.7] 0.098[7.1] 0.225[6.7] 4.111[7.4] 6.343[7.9] 1.356[5.6] To compare fairly, Random searches the subgraph of the same structure as those found by GE-L and GE-G, respectively. Embedding It constructs subgraphs with the same size as those found by GE-G. However, it utilizes DeepWalk[33] to obtain node embeddings, based on which top candidate nodes similar to the target are included to explain the target variable. LIME [35] It is the state-of-the-art black-box explanation method that works for classification models when input data are vectors rather than graphs. We randomly select 200 neigh- bors of each target node in the node feature vector space, with sampling probability weighted by the cosine similarity between the neighbors and the target. The feature vector is defined either as [34] (on Yelp review networks) or bag-of- words (on the citation networks). A binary/multiclass logistic regression model is then fitted on the sample and used to approximate the decision boundary around the target. LIME is less efficient than the subgraph search-based approaches since a new classification model has to be fitted for each target variable. LIME explains 30% of all review nodes, randomly sampled on Yelp review datasets, and explain all unlabeled variables on the citation networks. It cannot explain nodes in the remaining four networks due to the lack of feature vectors, which is one of the drawbacks of LIME. Comb It aggregates all candidate subgraphs from Beam[C] into a single graph as an explanation. This method can aggregate at most k (beam size) subgraphs and have at most kC variables. Here, we set k=3 and report the performance of the combined subgraph. The performances of the top candidate in Beam[C] with k=1 and k=3 are reported under GE-G (k=1) and GE-G (k=3). D. Explanation Accuracy Overall Performance Quantitative evaluation metrics For each method, we run BP on the extracted subgraph G for each target variable X to obtain a new belief bX (except for LIME that does not construct subgraphs). Explanation faithfulness is measured by the objective function in Eq. (4). In Table IV, we report the mean of the performance metric overall target variables, and the best methods are boldfaced. We also report the average size of explaining subgraphs in the square brackets after individual means. From Table IV, we can conclude that: 1) Comb always constructs the largest subgraph and performs best, due to multiple alternative high-quality explanations from the beam branches. 2) GE-G (k=3) is the runner up and better than GE- G (k=1), because the search space of GE-G (k=3) is larger than GE-G(k=1)'s. 3) The performance of Embedding is not very good, but still better than LIME in all cases. LIME has the worst performance, as it is not designed to explain BP and cannot take the network connections into account. 4) Faithfulness is positively correlated to subgraph size. Spam detection explanations On Yelp review networks, GE- L generates chain-like subgraphs. The average subgraph size is around four, even though the maximum capacity is five. This is because GE-L focuses on local information only and stops early when the prior of the last added node best explains the previously added message. Both GE-G versions extend the subgraph to the maximum size to produce a better explanation. Notice that Random performs better when imitating GE-G (k=1) than when imitating GE-L. The reason is that there are only two types of neighboring nodes of the target node and Random imitating GE-G has a higher chance to include the better neighbor and also generates larger subgraphs. Collective classification tasks In these tasks, GE-L constructs star-like subgraphs centered at the target node. On Cora the performance of GE-L is closer to (but and Citeseer, still inferior to) GE-G with both beam sizes, compared to their performance difference on Yelp. This is because the Cora and Citeseer networks consist of many small connected components, most of which contain less than five nodes, essentially capping GE-G's ability to add more explaining nodes to further bring up the faithfulness (evidenced by the average size of subgraphs found by GE-G smaller than 5). Compared with Yelp review networks, interestingly, Random imitating GE-G generates larger subgraphs but performs worse than Random imitating GE-L. The reason is that GE-G can add nodes far away from the target node and the random imitation will do the same. However, without the principled sensitivity of faithfulness with respect to the subgraph size, we downsize the subgraphs found by other methods (embedding, GE-G (k=1), GE-G (k=3), Random imitating GE-L and GE- G) to the same size of those found by GE-L, which may stop growing subgraphs before reaching the cap. The results obtained on four networks are shown in Fig. 6. On Yelp, GE- L, GE-G, and Random perform the same when the size is two since, with this size, the imitating Random has to adopt the same subgraph topology and node type as the subgraph found by GE-L and GE-G. As we downsize the best subgraphs found by GE-G (k = 3), a better subgraph with a large size may not be optimal when trimmed to size two, lacking the optimal substructures that facilitate dynamic programming variable can alter the target belief, leading to more insight into and trust on the BP. G. Explanation visualization and utility Explanation for Ratification One of the goals of expla- nations is to help end-users understand why the probabilistic beliefs are appropriate given the MRF, so that they can develop confidence in the beliefs and BP. This process is called "ratification" [41]. To attain this goal, Fig. 7 displays multiple explanations (trees) generated by Comb on the Karate Club network, with increasing size in Fig. 7 along with the faithful- ness measured by the distance from Eq. (4). One can see that the distance decreases exponentially fast as more nodes are added to the explanation. On each explaining subgraph (tree), we display beliefs found by BP on G and G so that the user is aware of the gap. Since insight is personal [41], the interface is endowed with flexibility for a user to navigate through alternatives, and use multiple metrics (distributional distance, subgraph size and topology) to select the more sensible ones. This design also allows the user to see how adding or removing an variable can alter the target belief, leading to more insight into and trust on the BP. Explanation for Verification MRF designers can use the explanations for verification of their design, including network parameters and topology. We demonstrate how to use the generated subgraphs to identify a security issue in spam detection. Specifically, we desire that a spam review should be detected with equal probability by the same spam detector, regardless of how many reviews their authors have posted. On the one hand, it has been found that well-camouflaged elite spammer accounts can deliver better rating promotion [27], a fact that has been exploited by dedicated spammers [49]. On the other hand, a spam detector can be accurate in detecting fake reviews for the wrong reason, such as the prolificacy of the reviewers [36]. We gather all reviews from the YelpChi dataset, and from the generated subgraph explanations, create four features, including whether a review is connected to its reviewer and target product, and the degree of its two potential neighbors. We then train a logistic regression model on these features to predict the probability of a review being a false positive (4,501), a false negative (6,681), and mis-classified (11,182), using predictions based on SpEagle [34]. The point is that Fig. 4. Left the computing time reduces superlinearly as the number of cores increases from 1 to 14. The parentheses enclose the number of hour(s) per unit. The square brackets enclose the running time of GE-L. For example, GE-G takes about 192 hours using one core on YelpZip, while GE-L costs 3 hours. Right Effect of pruning: as we increase the pruning rate to 99%, the subgraph explanation faithfulness is not degraded (shown by the 3 horizontal lines with solid markers), while the running time is reduced by 1/3. guidance in GE-G, Random can add nodes those are likely in the other classes than the class of the target node. E. Scalability We run GE-G (k=1) on Yelp review networks which have the most nodes to be explained. The scalability of the algorithm is demonstrated in two aspects in Fig. 4. First, the search can be done in parallel on multiple cores. As we increase the number of cores, the running time goes down super-linearly as the number of cores increases from 1 to 14. Second, candidate pruning plays a role in speeding up the search. We use 14 cores and increase the pruning ratio from 0 to 99% and obtain about ×1.7 speedup at most. Importantly, the explanation faithfulness is not affected by the pruning, shown by the three lines at the bottom of the right figure (200 × mean objective). F. Sensitivity analysis There are two hyperparameters for the subgraph search and we study the sensitivity of the explanation faithfulness with respect to these two parameters. First, when there are labeled nodes on G, the explanation subgraphs may include a labeled node in the explanation, and the more labeled nodes, the more likely the explanation subgraphs will include these nodes. The question here is whether including such labeled nodes will improve explanation faithfulness, and does our method require a large number of labeled nodes. To answer the questions, on the four networks (Cora, Citeseer, PubMed, and Bioinfor- matics), we vary the ratio of labeled nodes in the ranges of {5%, 10%, 20%, 30%, 40%, 50%, 60%, 70%, 80%, 90%, 95%}. The explanation performances are shown in Fig. 5. Overall different ratios on all four networks, Comb is the best and GE-G is runner-up. On the Cora and Citeseer networks, the performances of all methods are not very sensitive to the ratio of labeled nodes. On the PubMed network, there are improvements in most baselines except LIME becomes worse. One can also conclude that LIME, designed for parametric models including deep models, is outperformed by methods designed specifically for MRF. On the Bioinformatics, LIME is not available and GE-G and Comb have better performance. Second, subgraphs containing more nodes perform better since they have more contexts of the target. To evaluate the 2468101214Number of CPU cores246810Relative Running timeYelpChi (X2) [1.6%]YelpNYC(X16) [1.9%]YelpZip (X32) [1.7%]020406080100Pruning Ratio0.00.20.40.60.81.01.2YelpChi (X2)YelpNYC(X16)YelpZip (X32) Fig. 5. Explanation faithfulness (the smaller the better) on citation networks while the ratio of labeled nodes increases. Random (L) is the random baseline that imitate GE-L. Similar for Random (G). Fig. 6. Relationship between size of subgraph and faithfulness model. In [35, 2], parametric or non-parametric models are fitted to approximate a more complex model locally. The idea of approximation is similar to that in GraphExp, with different approximation loss functions. We have seen in the experiments that a parametric model won't deliver good explanations to the inference outcomes on a graphical model. In [21], HMM is trained to approximate an RNN model, resembling the idea of using a simpler grapical model to approximate a more complex graphical model. However, both HMM and RNN are linear while GraphExp focuses on graphs with more general topology, including cycles. Explainable bayesian networks were studied in the 1980's and 1990's [31, 41], driven by the needs to verify and commu- nicate the inference outcomes of Bayesian networks in expert systems. It has long been recognized that human users are less likely to adopt expert systems without interpretable and probable explanations [45]. More recently, Bayesian networks were formulated as a multi-linear function so that explanations can be facilitated by differentiation [7]. The fundamental difference between GraphExp and these prior works is that we handle MRFs with cycles while they handled Bayesian networks without cycles. The differentiation-based explanation of MRFs in [5] finds a set of important netowrk parameters (potentials) to explain changes in the marginal distribution of a target variable without explaining any inference procedure. GraphExp generates graphical models consisting of prominent variables for reproducing the inference of a BP procedure on a larger graph. Interpretable graphical models are also studied under the hood of topic models [6], where the focus is to communicate the meaning of the inference outcomes through measures or prototypes (which words belong to a topic), rather than explaining how the outcomes are arrived at. REFERENCES [1] Edoardo Amaldi and Viggo Kann. On the approximability of minimizing nonzero variables or unsatisfied relations in linear Fig. 7. Larger red nodes are the nodes explained. Other red nodes are the explaining nodes. The green nodes are the newly added ones. the above mistakes should not depend on the prolificacy of the connected reviewers and products. However, we found that a sizable subset of false negatives (1,153 out of 6,681) are due to the influence from the review node only based on our explanations. Moreover, the logistic model shows that the influence of the degree of the neighboring reivewer contributes the most to the probability of FN. This is a serious security issue: a spam from an prolific reviewers is more likely to be missed by SpEagle. V. RELATED WORK To explain differentiable parametric predictive models, such as deep networks [19] and linear models [26, 47], the gradi- ents of the output with respect to the parameters and input data [39] can signify key factors that explain the output. However, graphical models aim to model long range and more complicated types of interaction among variables. If a model is too large or complex to be explained, an approximating model can provide certain amount of transparency to the full 20406080Labeled node ratio (Cora)0.00.20.40.60.81.01.21.4Explanation faithfulnessEmbeddingLIMEGE-LRandom (L)GE-GRandom (G)Comb20406080Labeled node ratio (Citeseer)0.00.20.40.60.81.01.21.4Explanation faithfulnessEmbeddingLIMEGE-LRandom (L)GE-GRandom (G)Comb20406080Labeled node ratio (PubMed)0.00.20.40.60.81.01.21.4Explanation faithfulnessEmbeddingLIMEGE-LRandom (L)GE-GRandom (G)Comb20406080Labeled node ratio (Bioinformatics)0.00.51.01.52.02.53.0Explanation faithfulnessEmbeddingGE-LRandom (L)GE-G (k=1)Random (G)Comb2 (2)3 (2)4 (2)5 (2)Subgraph size (YelpZip)0.00.10.20.30.40.50.60.7Explanation faithfulnessEmbeddingGE-LRandom (L)GE-G (k=1)Random (G)GE-G (k=3)2 (1.07)3 (2.21)4 (3.45)5 (13.1)Subgraph size (PubMed)0.00.51.01.52.02.53.0Explanation faithfulnessEmbeddingGE-LRandom (L)GE-G (k=1)Random (G)GE-G (k=3)2 (82.9)3 (38.6)4 (32.8)5 (64.8)Subgraph size (Blogcatalog)02468Explanation faithfulnessEmbeddingGE-LRandom (L)GE-G (k=1)Random (G)GE-G (k=3)2 (19.1)3 (2.84)4 (3.71)5 (42.2)Subgraph size (Bioinformatics)0.00.51.01.52.0Explanation faithfulnessEmbeddingGE-LRandom (L)GE-G (k=1)Random (G)GE-G (k=3)Centered: target nodeRed: constructed beforeGreen: latest addedNumber: probability systems. 1998. Theoretical Computer Science, 209(1-2):237 -- 260, [2] David Baehrens, Timon Schroeter, Stefan Harmeling, Motoaki Kawanabe, Katja Hansen, and Klaus-Robert M Azller. How to explain individual classification decisions. Journal of Machine Learning Research, 11(Jun):1803 -- 1831, 2010. [3] Dhruv Batra, Payman Yadollahpour, Abner Guzman-Rivera, and Gregory Shakhnarovich. Diverse m-best solutions in markov In European Conference on Computer Vision, random fields. pages 1 -- 16. Springer, 2012. [4] Rich Caruana, Hooshang Kangarloo, JD Dionisio, Usha Sinha, and David Johnson. Case-based explanation of non-case-based learning methods. In Proceedings of the AMIA Symposium, page 212. American Medical Informatics Association, 1999. [5] Hei Chan and Adnan Darwiche. Sensitivity analysis in markov In International Joint Conference on Artificial In- networks. telligence, volume 19, page 1300. LAWRENCE ERLBAUM ASSOCIATES LTD, 2005. [6] Jonathan Chang, Sean Gerrish, Chong Wang, Jordan L Boyd- Graber, and David M Blei. Reading tea leaves: How humans information interpret processing systems, pages 288 -- 296, 2009. In Advances in neural topic models. [7] Adnan Darwiche. A differential approach to inference in bayesian networks. Journal of the ACM (JACM), 50(3):280 -- 305, 2003. [8] Jerome Friedman, Trevor Hastie, and Robert Tibshirani. Sparse inverse covariance estimation with the graphical lasso. Bio- statistics, 9(3):432 -- 441, 2008. [9] Joseph Gonzalez, Yucheng Low, and Carlos Guestrin. Residual splash for optimally parallelizing belief propagation. In Artifi- cial Intelligence and Statistics, pages 177 -- 184, 2009. [10] Bryce Goodman and Seth Flaxman. European union regulations on algorithmic decision-making and a right to explanation. AI Magazine, 38(3):50 -- 57, 2017. [11] Isabelle Guyon and Andr´e Elisseeff. An introduction to variable and feature selection. Journal of machine learning research, 3(Mar):1157 -- 1182, 2003. [12] Tamir Hazan and Amnon Shashua. Norm-product belief propa- gation: Primal-dual message-passing for approximate inference. IEEE Transactions on Information Theory, 56(12):6294 -- 6316, 2010. [13] Jean Honorio, Dimitris Samaras, Irina Rish, and Guillermo In Cecchi. Variable selection for gaussian graphical models. Artificial Intelligence and Statistics, pages 538 -- 546, 2012. [14] Qiang Huang, Ling-Yun Wu, and Xiang-Sun Zhang. An efficient network querying method based on conditional random fields. Bioinformatics, 27(22):3173 -- 3178, 2011. [15] Saehan Jo, Jaemin Yoo, and U Kang. Fast and scalable distributed loopy belief propagation on real-world graphs. In Proceedings of the Eleventh ACM International Conference on Web Search and Data Mining, pages 297 -- 305. ACM, 2018. [16] Matthew Johnson, David K Duvenaud, Alex Wiltschko, Ryan P Adams, and Sandeep R Datta. Composing graphical models with neural networks for structured representations and fast in- ference. In Advances in neural information processing systems, pages 2946 -- 2954, 2016. [17] U Kang, Duen Horng, et al. Inference of beliefs on billion-scale graphs. 2010. [18] Ross Kindermann. Markov random fields and their applications. American mathematical society, 1980. [19] Pang Wei Koh and Percy Liang. Understanding black-box the predictions via influence functions. 34th International Conference on Machine Learning-Volume 70, pages 1885 -- 1894. JMLR. org, 2017. [20] Daphne Koller and Nir Friedman. Probabilistic graphical In Proceedings of models: principles and techniques. MIT press, 2009. [21] Viktoriya Krakovna and Finale Doshi-Velez. Increasing the in- terpretability of recurrent neural networks using hidden markov models. arXiv preprint arXiv:1606.05320, 2016. [22] Isaac Lage, Emily Chen, Jeffrey He, Menaka Narayanan, Been Kim, Sam Gershman, and Finale Doshi-Velez. An evaluation of the human-interpretability of explanation. arXiv preprint arXiv:1902.00006, 2019. [23] Tao Lei, Regina Barzilay, and Tommi Jaakkola. Rationalizing neural predictions. arXiv preprint arXiv:1606.04155, 2016. [24] Ming-Hui Li, Lei Lin, Xiao-Long Wang, and Tao Liu. Protein -- protein interaction site prediction based on conditional random fields. Bioinformatics, 23(5):597 -- 604, 2007. [25] Tania Lombrozo. The structure and function of explanations. Trends in cognitive sciences, 10(10):464 -- 470, 2006. [26] Yin Lou, Rich Caruana, and Johannes Gehrke. Intelligible In Proceedings of models for classification and regression. the 18th ACM SIGKDD international conference on Knowledge discovery and data mining, pages 150 -- 158. ACM, 2012. [27] Michael Luca. Reviews, reputation, and revenue: The case of yelp. com. Com (March 15, 2016). Harvard Business School NOM Unit Working Paper, (12-016), 2016. [28] George A Miller. The magical number seven, plus or minus two: Some limits on our capacity for processing information. Psychological review, 63(2):81, 1956. [29] Galileo Mark Namata, Stanley Kok, and Lise Getoor. Collective graph identification. In Proceedings of the 17th ACM SIGKDD international conference on Knowledge discovery and data mining, pages 87 -- 95. ACM, 2011. [30] George L Nemhauser, Laurence A Wolsey, and Marshall L Fisher. An analysis of approximations for maximizing submod- ular set functions. Mathematical programming, 14(1):265 -- 294, 1978. [31] Steven W Norton. An explanation mechanism for bayesian In Machine Intelligence and Pattern inferencing systems. Recognition, volume 5, pages 165 -- 173. Elsevier, 1988. [32] Judea Pearl. Probabilistic reasoning in intelligent systems: networks of plausible inference. Elsevier, 2014. [33] Bryan Perozzi, Rami Al-Rfou, and Steven Skiena. Deepwalk: In Proceedings of Online learning of social representations. the 20th ACM SIGKDD international conference on Knowledge discovery and data mining, pages 701 -- 710. ACM, 2014. [34] Shebuti Rayana and Leman Akoglu. Collective opinion spam In Pro- detection: Bridging review networks and metadata. ceedings of the 21th acm sigkdd international conference on knowledge discovery and data mining, pages 985 -- 994. ACM, 2015. [35] Marco Tulio Ribeiro, Sameer Singh, and Carlos Guestrin. Why should i trust you?: Explaining the predictions of any classifier. In Proceedings of the 22nd ACM SIGKDD international con- ference on knowledge discovery and data mining, pages 1135 -- 1144. ACM, 2016. [36] Andrew Slavin Ross, Michael C Hughes, and Finale Doshi- Velez. Right for the right reasons: Training differentiable arXiv preprint models by constraining their explanations. arXiv:1703.03717, 2017. [37] Chris Russell. Efficient search for diverse coherent explanations. arXiv preprint arXiv:1901.04909, 2019. [38] Barbara G Ryder. Constructing the call graph of a pro- IEEE Transactions on Software Engineering, (3):216 -- gram. 226, 1979. [39] Karen Simonyan, Andrea Vedaldi, and Andrew Zisserman. Deep inside convolutional networks: Visualising image clas- arXiv preprint sification models arXiv:1312.6034, 2013. and saliency maps. [40] Simone Stumpf, Erin Sullivan, Erin Fitzhenry, Ian Oberst, Weng-Keen Wong, and Margaret Burnett. Integrating rich user In Proceedings of feedback into intelligent user interfaces. the 13th international conference on Intelligent user interfaces, pages 50 -- 59. ACM, 2008. [41] Henri J Suermondt. Explanation in bayesian belief networks. 1993. [42] Charles Sutton, Andrew McCallum, et al. An introduction to conditional random fields. Foundations and Trends R(cid:13) in Machine Learning, 4(4):267 -- 373, 2012. [43] Lei Tang and Huan Liu. Relational learning via latent social dimensions. In Proceedings of the 15th ACM SIGKDD inter- national conference on Knowledge discovery and data mining, pages 817 -- 826. ACM, 2009. [44] Wenbin Tang, Honglei Zhuang, and Jie Tang. Learning to infer social ties in large networks. In Joint european conference on machine learning and knowledge discovery in databases, pages 381 -- 397. Springer, 2011. [45] Randy L Teach and Edward H Shortliffe. An analysis of physi- cian attitudes regarding computer-based clinical consultation systems. Computers and Biomedical Research, 14(6):542 -- 558, 1981. [46] Sandra Wachter, Brent Mittelstadt, and Chris Russell. Counter- factual explanations without opening the black box: Automated decisions and the gpdr. Harv. JL & Tech., 31:841, 2017. [47] Mike Wojnowicz, Ben Cruz, Xuan Zhao, Brian Wallace, Matt Wolff, Jay Luan, and Caleb Crable. influence sketching: Finding In 2016 IEEE influential samples in large-scale regressions. International Conference on Big Data (Big Data), pages 3601 -- 3612. IEEE, 2016. [48] Chen Yanover, Talya Meltzer, and Yair Weiss. Linear program- ming relaxations and belief propagation -- an empirical study. Journal of Machine Learning Research, 7(Sep):1887 -- 1907, 2006. [49] Haizhong Zheng, Minhui Xue, Hao Lu, Shuang Hao, Haojin Zhu, Xiaohui Liang, and Keith Ross. Smoke screener or straight shooter: Detecting elite sybil attacks in user-review social networks. arXiv preprint arXiv:1709.06916, 2017. [50] Marinka Zitnik and Jure Leskovec. Predicting multicellular function through multi-layer tissue networks. Bioinformatics, 33(14):i190 -- i198, 2017.
1801.10527
2
1801
2018-08-15T08:51:12
Analysing Collective Behaviour in Temporal Networks Using Event Graphs and Temporal Motifs
[ "cs.SI", "nlin.AO", "physics.soc-ph" ]
Historically studies of behaviour on networks have focused on the behaviour of individuals (node-based) or on the aggregate behaviour of the entire network. We propose a new method to decompose a temporal network into macroscale components and to analyse the behaviour of these components, or collectives of nodes, across time. This method utilises all available information in the temporal network (i.e. no temporal aggregation), combining both topological and temporal structure using temporal motifs and inter-event times. This allows us create an embedding of a temporal network in order to describe behaviour over time and at different timescales. We illustrate this method using an example of digital communication data collected from an online social network.
cs.SI
cs
Analysing Collective Behaviour in Temporal Networks Using Event Graphs and Temporal Motifs Andrew Mellor∗ Mathematical Institute, University of Oxford, Oxford, OX2 6GG, UK Abstract Historically studies of behaviour on networks have focused on the be- haviour of individuals (node-based) or on the aggregate behaviour of the entire network. We propose a new method to decompose a temporal net- work into macroscale components and to analyse the behaviour of these components, or collectives of nodes, across time. This method utilises all available information in the temporal network (i.e. no temporal aggrega- tion), combining both topological and temporal structure using temporal motifs and inter-event times. This allows us create an embedding of a temporal network in order to describe behaviour over time and at dif- ferent timescales. We illustrate this method using an example of digital communication data collected from an online social network. 1 Introduction Modern methods of data collection have given researchers access to ever richer datasets, both in terms of their descriptive power and their temporal resolution. Where previously data would be a representation of an instant in time or ag- gregated over a time interval, in many fields we now have access to sequential (and often timestamped) records or observations. The mining of this sequential data, or event streams, is now an important task with a particular focus being on creating algorithms that extract information in real-time. Event stream data is perhaps most prevalent in the digital context, where data collected can be easily automated. Online social networks such as Twitter [1] allow access to real-time streams of messages between users of the platform. Similarly, researchers and telecom providers have access to telephone and text records (call participants, durations, etc.) which can be analysed to describe our circadian rhythms [2], closest friends [3], or the differences in call behaviour be- tween genders [4]. Event stream data is not limited to communication however. ∗[email protected] 1 Other examples include, but are limited to, website clickstreams [5], proximity networks [6], transportation networks [7], and biological interactions [8]. To address the challenges that come with temporal data there have been many recent advances in the study of temporal networks [9, 10, 11]. Temporal networks are a natural extension from static networks although there are many ways to model them depending on the degree of temporal aggregation and the type of analysis required. Typically temporal networks are aggregated into time intervals (binning events into intervals of an hour for example) to create a se- quence of static networks which can then be analysed using concepts adapted from static graph theory [12, 11]. However, arbitrarily discretising time can dis- tort results by destroying temporal correlations and obscuring causal relations. More recent work has avoided this issue by considering a network of temporal events (time-stamped edges) as opposed to individual nodes themselves [13, 14]. This allows the temporal network to be represented as a single weighted static network which can be decomposed by pruning edges based on edge weights. The connected components of this network provide a natural partition of the data whereby events in close temporal and topological proximity remain connected. In this article we describe a new method to analyse collective behaviour in temporal networks using the network decomposition in [13, 14] and cluster the resulting temporal components using a combination of temporal and topological features. In Section 2 we detail our methodology and feature section. In partic- ular we introduce three new features in the form of the motif entropy, inter-event time entropy, and the degree imbalance. Sections 3 and 4 are devoted to the ap- plication of the method to data collected from Twitter, and finally in Section 5 we discuss the challenges and issues with such methods and highlight avenues for further research. 1.1 Related Work This article combines and extends higher-order network models, temporal mo- tifs, and network embedding. Motifs have been previously used to understand behaviour in networks [15, 4, 16]. In [4] it is found that there are differences in the call behaviour of each gender (measured by the differences in temporal motif distributions), although the change of this behaviour over time is not investigated. The behaviour of Wikipedia editors is characterised in [15] using temporal motifs, who show that the observed behavioural patterns are relatively stable over the course of a number of years. Network (or node) embedding involves characterising a network (or node in a network) by an n-dimensional feature vector. After embedding, methods that have traditionally been used for image-recognition or natural language process- ing such a deep neural networks or random forests can be used for link prediction, clustering, or graph synthesis. There have numerous suggestions for network (or node) embeddings [17, 18, 19, 20]. Node embeddings can be generated by con- sidering local sampling of the network around the node, either iteratively [19] or through a random walk exploration [18, 20]. Walk-based embeddings are 2 well grounded (having connections to the graph Laplacian), although the em- beddings themselves can be difficult to interpret. Similar approaches have been implemented to characterise subgraphs [21] or entire graph structures [22]. The latter instead using a set of predefined features (clustering, assortativity, etc.) to create an embedding, rather than a random walk exploration. More recently there have been attempts to extend node embeddings to the dynamic case. One approach creates node embeddings by considering random temporal walks [23]. These are random walks that have the added constraint of traversing edges in the order at which they appear. There are approaches to embed dynamic graphs [24] however these are reliant on discretising time and creating a sequence of aggregate static networks. The representation of the temporal network we use is a second-order time- unfolded model, a combination of the higher-order models of [25] and time- unfolded networks of [26]. The decomposition of temporal network consists of using the connected components these higher-order models (more detail given in Section 2). This is the first instance of embedding and clustering these components, so there is currently not a directly comparable benchmark. We instead compare our decomposition to the more typical decomposition fixed- width time intervals. The example in Sections 3 and 4 considers directed messages on Twitter. Many studies of Twitter use the content of messages (text and media) to model topics of conversation, perform sentiment analysis, and identify viral content [27, 28, 29, 30]. Topics are generated by aggregating messages which have similar word usage. We instead take the content-agnostic approach and instead model only the connections between users. 2 Methodology In this section we describe the methods used to model and analyse temporal network data. Our analysis is split into three parts; temporal decomposition, feature extraction, and clustering. 2.1 Event Graphs and Temporal Decomposition Formally we describe a temporal network G by the triple (V, T, E) where V ⊂ N is a set of nodes, T ⊂ R+ 0 a set of interaction times, and E ⊂ V 2 × T , the set of temporal events. Directed, instantaneous events take the form ei = (ui, vi, ti) corresponding to an edge appearing from node ui to node vi at time ti. The remainder of this article we assume that events are both directed and instantaneous, although the methods can easily be generalised to undirected or persistent events. We model the temporal network as an event graph (EG) [13]. An EG is a second-order time-unfolded model of the temporal network, where the events of the original network are the nodes of the EG. The EG is described by the tuple G = (E, L), where E is the set of events, and L is the set of edges. Events 3 are linked to the subsequent events for each node in that event (resulting in a directed acyclic graph with a maximal in/out degree of two). Weighting these edges with the time between the two events (inter-event time) gives rise to a weighted, directed graph of temporal events. Each edge is also associated with a two-event temporal motif [16] which describes the topological relationship between the nodes in each event (see Figure 1). The ∆t-EG is a subgraph of the EG where the edges are removed based on the edge weights. The new set of edges is L∆t = {(ei, ej) ∈ Ltj − ti ≤ ∆t} with the ∆t-EG given by G∆t = (E, L∆t). This allows us to study the temporal- topological structure of the ∆t-EG as a function of ∆t, and decompose the event sequence into smaller subsequences. Let C∆t be the set of weakly-connected components of the ∆t-EG. Each component c ∈ C∆t is described by the tuple (Ec, Lc ∆t = L∆t. The temporal components (which we will use synonymously with weakly-connected component) of G∆t capture sequences of events which occur in relatively close proximity and share one or more nodes which we assume to imply a level of causality between events. Algorithmic details of how to construct the EG are given in Appendix A.1. ∆t) with Sc Ec = E and Sc Lc 2.2 Feature Extraction and Component Embedding How can we characterise these temporal components? We consider a set of fea- tures which can be split into purely temporal, purely topological, and topological- temporal features. For this study we will consider only features which are inde- pendent of the temporal component size, or scale-invariant. Here the component 'size' refers to number of events, the number of nodes, or the duration of the component. Naturally this allows us to compare behaviour in components of different sizes and across different datasets. In the rest of this section we describe the features used in this study. A full list of features considered is given in Table 1. 2.2.1 Topological-Temporal Features 1 2 2 1 2 1 2 1 1 2 1 2 ABAB ABBA ABAC ABCA ABBC ABCB Figure 1: All possible two-event temporal motifs. Events are labelled with the order which they occur. Temporal motifs. Temporal motifs are repeatedly observed patterns of interaction across time. We consider temporal motifs as defined in [16] although 4 we can equally use the definition in [31]1 by considering a different event graph structure [32]. In particular we consider only two-event motifs, of which there are six (shown in Figure 1 along with a shorthand description of each). We can also incorporate different event types (or event colours) into a temporal motif (see Appendix A.2). For example, if there are two event types x and y the possible motifs derived from the ABBA motif are ABxBAx, ABxABy, AByBAx, and AByBAy. There are 24 possible motifs of this variety (6 × 22). Modelling multiple event types allows us to better distinguish between different types of behaviour in temporal networks (the differences between calls and text in a communication network, for example), however it increases the number of possible motifs. We measure the prevalence of each motif type present in a component by the fraction of all observed motifs. This gives us an empirical motif distribution for the component. Typically the prevalence of motifs is uninformative without reference to a baseline model [16, 4], or a comparative dataset. In this case since we are comparing different temporal components (and not commenting on relative prevalence) we can use the motif counts as they are. We do however compare our method to an ensemble of time-shuffled replicates of our data in Section 4. We are also interested in how diverse a component is in terms of the motifs present. To quantify this we introduce the entropy of the motif distribution, i.e. SMOT = Xm∈M pm log2(pm) (1) where M is the set of all possible motifs, and pm is the probability of observing motif type m. This has the desired property that SMOT = 0 when only one type of motif is present, and takes a maximal value of log2 M when all M motif types are equally likely. This suggests the rescaling SMOT = SMOT log2 M (2) which maps to the unit interval. Temporal motifs have been previously used to analyse behaviour in temporal networks and so should be a suitable feature to distinguish behaviour across the constituent temporal components of the network. We could also consider higher- order motifs (containing three or more events) however the number of possible motifs increases exponentially with the motif size. This makes these higher- order motifs both costly to compute and also poorer features on small networks as the counts for each motif are likely to be small. 1 The two definitions differ in two aspects. Motifs in [16] require events for each node in the motif to be consecutive and the time between consecutive events has an upper bound whereas events in [31] do not need to be consecutive and the entire motif must occur within a fixed time window (with no prescription of inter-event time). 5 2.2.2 Pure Topological Features These features consider the static graph aggregation of the temporal component given by the adjacency matrix A(c) uv =(1 0 if ∃t s.t (u, v, t) ∈ Ec otherwise. That is, an edge is present in the aggregated graph if an event occurred along that edge in the duration of the temporal component. While this removes any temporal information about the component it allows us to consider higher-order properties of the network without explicitly calculating higher-order temporal motifs. The structural features of static graphs have been well documented [33, 34]. Here we consider three well known features, and introduce a new feature, the degree imbalance. Clustering coefficient. The clustering coefficient C measures the degree of transitivity in the graph and is given by the ratio number of closed triplets of nodes to the number of connected triplets of nodes. This gives a measure of the likelihood that nodes a and b are connected, given a connection between a and c and between c and b also. For this feature we ignore the direction of edges. Degree Imbalance. The degree imbalance measures the average difference between the degrees of connected nodes. Let α, β ∈ {in, out} index the degree type, and let sα i be the α- and β-degree of the source and target node for edge i. The degree imbalance is given by i and tβ µ(α,β) = m−1Pi(sα maxi sα i − tβ i ) i − tβ i (3) where m is the number of edges in the graph, and we sum over all possible edges. We also normalise by the maximum difference between node degrees. The degree imbalance takes values in [−1, +1] with a value of µ(α,β) = ±1 indicating that for all edges the α-degree of the source is greater/less (resp.) than the β-degree of the target, and this difference is the same for all edges. By considering the joint degree distribution it can be shown that µ(in, out) = 0 for all graphs and so this case will be omitted. We use this feature to assess how 'hub-like' the network is. This feature is used, as opposed to the directed degree assortativity [35] as the degree assor- tativity is not well defined on networks where there is no variance in the node degrees (and this case is not addressed). An example of such a case is an inward star graph where the out-degree of all edge sources (the peripheral nodes) is one, and the in degree of all edge targets (the hub) is the number of peripheral nodes. Normalisation to the unit interval can be achieved with µ(α,β) = µ(α,β) + 1 2 . (4) 6 Edge reciprocity. The edge reciprocity is a measure of how many events in the conversation are reciprocated and is given by R = m−1Xi,j Aij Aji (5) where m is the total number of edges as before. This feature picks up instances of reciprocation that are not captured in an ABBA motif (either due to other intermediate motifs being formed, or the two events not being close in temporal proximity). Edge density. The edge density is the number of edges present in the graph as a fraction of all possible edges. Mathematically this is given by ρ = 1 N (N − 1)Xi,j Aij , (6) where N is the number of nodes in the graph. The presence of an N 2 term in the denominator indicates that this feature is only scale-independent on the assumption that the network is dense (i.e. node degrees ki are O(N )). Since we do not wish to make that assumption, the edge density will only be used as a descriptor and not a feature in the model. 2.2.3 Pure Temporal Features Inter-event times (IETs). The times between consecutive events has been the focus of many studies [36, 37, 38]. We consider the distribution of IETs along all edges of the EG, that is the times between consecutive events for each node in the temporal component. The IET distribution is dependent on the duration of the conversation (the maximal IET is bounded by the conversation duration) and so cannot be used as a scale-invariant feature. We instead characterise the diversity of the IETs by considering the entropy, as with motifs. The IET is a continuous variable however so we first need to discretise it into fixed-width bins. Let I be the set of intervals that partition the set of IETs and pi be the probability of an IET being in interval i ∈ I, then the IET entropy is given by SIET = −Xi∈I pi log2(pi). (7) The IET entropy has the property of being zero for periodic events and is maximal for a uniform distribution of IETs. The entropy is desirable over the variance in the case of events with alternating periods, e.g. 2-4-2-4. In this example, the variance is dependent on the distance between the two periods and can be arbitrarily large whereas the entropy is constant and is close to zero regardless of distance between the two periods. We normalise the IET entropy by dividing by the maximum possible entropy for that number of bins, i.e. SIET = SIET log2 I . 7 (8) Activity. Another related temporal feature we consider is the activity of the temporal component, denoted by λ, and defined to be the number of events per unit time. To normalise the activity feature we apply the transformation λ = 1 − e−λ (9) which takes values in [0, 1). 2.2.4 Summary statistics The summary features we will use to describe temporal components are the number of events, the number of nodes, and the total duration or lifetime of the component. For a component consisting of event set E these are Nevents(E) = E, Nnodes(E) =(cid:12)(cid:12)(cid:12)(cid:12)(cid:12)(cid:12) D(E) = max [(u,v,t)∈E , (u ∪ v)(cid:12)(cid:12)(cid:12)(cid:12)(cid:12)(cid:12) t − min (u,v,t)∈E (u,v,t)∈E (10) (11) (12) t, respectively. As these features by definition explicitly depend on the size of the component we will not include them in our feature-space. They do however provide important context to examine individual components. Feature Symbol Range Scale-invariant # Nodes # Events Duration (seconds) Edge Density Motif Prevalence (multiple) Motif Entropy IET Entropy Degree Imbalance (in,in) Degree Imbalance (out,in) Degree Imbalance (out,out) Clustering Reciprocity Activity Nnodes Nevents D ρ pm SMOT SIET µ(in,in) µ(out,in) µ(out,out) C R λ [2, ∞) [2, ∞) [1, ∞) [0, 1] [0, 1] [0, log2 M ] [0, log2 I] [−1, 1] [−1, 1] [−1, 1] [0, 1] [0, 1] [0, ∞) No No No No Yes Yes Yes Yes Yes Yes Yes Yes Yes Table 1: List of features used to describe temporal components. Features are rescaled so that all values lie in [0, 1] (see text). The prevalence of each motif is an individual feature, meaning for two-event motifs with two possible event types there are 24 individual features. 8 2.3 Embedding & Clustering We create a feature vector xc for each temporal component using the above features. Formally we define an encoding function f : C∆t → Rd which maps a temporal component into the d-dimensional vector space. In total we have 32 different features, or dimensions. We then normalise our feature vectors by rescaling to unit length, i.e. xc = xc/xc . To cluster temporal components we first need to define a suitable distance function. There are many ways to do this however we choose to use the Eu- clidean distance between temporal components. This gives us pairwise distance matrix between all temporal components. From the distance matrix we can construct a hierarchical clustering of components by employing Ward's method [39]. Finally we use the silhouette coefficient [40] to determine the optimal number of clusters. The silhouette coefficient score for a sample i is given by s(i) = dinter(i) − dintra(i) max(dintra(i), dinter(i)) (13) where dintra and dinter are the intra-cluster distance (distance to centre of as- signed cluster) and inter-cluster distance (distance to the centre of the nearest alternate cluster) respectively. The silhouette coefficient for the dataset is then the average across all samples and takes values in [−1, 1] with a value of +1 indicating perfect clustering and a value of −1 indicating the worst possible clustering. 3 Data There are many sources of timestamped event data, such as electronic commu- nication, website clickstreams, proximity networks, or transportation schedules, for example. To illustrate our method we consider data collected from Twit- ter and investigate whether we can identify different types of distinct collective behaviours in the conversations that users have online. We take Twitter data sampled by keyword using the Twitter Streaming API2. In particular we collect tweets which contain the word Emirates (and common variants). We subsequently collate the accounts present in the sample and collect all tweets they have participated in during the course of the entire day using the REST API. This procedure is important for two reasons. Firstly, we want to be able to capture all conversations surrounding a particular topic and subsequent responses to sampled tweets may or may not mention the keyword explicitly. Secondly, as the temporal motifs are formed of subsequent events, the omission of any event will introduce error. We sampled our keyword using the above procedure over one day in Novem- ber 2017. The statistics of the data sampled are presented in Table 2. 2 See developer.twitter.com 9 # Tweets # Events # Users % Retweets 161,730 130,360 48,249 52.95 Table 2: Data collected from Twitter over a 24 hour period. Tweets with no mentions (i.e. are not directed) do not constitute an event hence there are fewer events than tweets. 3.1 Modelling Considerations In the data collection we collect two types tweet, messages (original pieces of content) and retweets (duplicates of previous tweets which are reshared). We model these tweets as sequence of temporal events E where each event ei ∈ E takes the form (ui, vi, ti) which describes the instantaneous contact from node ui to node vi at time ti. Here a tweet from account u to account v (directing their message to them) at time t becomes a temporal event (u, v, t). If multiple accounts are mentioned within a tweet then multiple events are created3. A retweet by account u of a tweet from account v at time t becomes an event (v, u, t) which reflects the direction that information has travelled in the event. These two types of event can be considered as either a push (message) or pull (retweet) of information. 3.2 Time-shuffled Ensembles Without a suitable reference model we instead benchmark our findings using ensembles of randomised time-shuffled data. To shuffle the data we permute the event times randomly while keeping the node pairs constant. This preserves network structure and the numbers of events between all pairs of nodes but destroys all temporal correlation between events [41]. 4 Results We construct the EG and set the edge (inter-event time) threshold to be ∆t = 240s (or four minutes). The 4min-EG has 4137 components with at least five events. This choice of ∆t was chosen to balance the number of temporal com- ponents with component size; too small a value would possibly split up con- versations and create components of only a small number of events, and too large a value leads to fewer large components that may be unrelated. Further discussion of this choice is given in Appendix B.1. In Figure 2 we plot the activity of the ten largest components in an hour period. Immediately we can see the differences of the temporal activity patterns of these components; some components occur over the space of 10 minutes (C10), others span the entire interval (C4). We can also see clear distinctions between the inter-event times 3 In this study we restrict ourselves to events containing only two accounts/nodes. We can however extend this analysis to multiple-node events (or hyper-events). 10 for the components, for example the contrast between the bursty behaviour of component C6 and component C5 where activity levels peak and then decay. t n e n o p m o C C10 C9 C8 C7 C6 C5 C4 C3 C2 C1 12:00 12:15 12:30 Time (GMT) 12:45 13:00 Figure 2: Temporal barcode for a one hour window of the 4min-EG. The largest 10 temporal components (by number of events) of the 4min-EG are plotted (C1 being the largest). Each vertical black line represents the time at which an event occurred. We see distinct patterns in behaviour in terms of event density, component duration, and inter-event time distributions (gaps between events). 4.1 Discriminative features The component barcodes portray only the duration, activity, inter-event times, and number of events in each component. We can systematically investigate which are the most important features by applying principal component anal- ysis (PCA) to reduce the dimensionality of the feature-space. The first three components of the PCA account for 71% of the variance of component features. Visualising the temporal components in the full feature-space is not feasible and so we instead reduce the dimensionality of the data using the t-SNE algorithm [42] (Figure 3). The high-dimensionality makes the results difficult to plot but does not hamper the rest of our analysis which is conducted on the full feature-space. In Table 3 we show the largest constituent features of the components of the PCA, ordered by magnitude. The motif entropy is also one of the distinguishing features - how diverse the conversation is in terms of the motifs present. This is enlightening as low motif entropy can be indicative of predictable, system- atic behaviour, possibly highlighting automated accounts. Similarly, low IET entropy implies periodic (or predictable) activity, which again provides further evidence of automation. The presence of reciprocity is also distinguishing fea- ture of an online conversation, i.e., is whether the conversation is 'one-sided', or just consists of back-and-forth interaction. Degree imbalance being a promi- 11 Cluster 1 Cluster 2 Cluster 3 Cluster 4 Cluster 5 2 i n o s n e m D i Dimension 1 Figure 3: Scatterplot of the 4137 component features, using the t-SNE algo- rithm [42] to reduce feature-space to two dimensions. The cluster analysis is conducted on the full feature space and dimensionality reduction is used solely for visualisation. Components are coloured by their assigned clustering (see text). PCA Component 1 (36%) 2 (19%) 3 (15%) ABrCBr ABmCBm µ(out,in) ABmCBm SIET µ(out,in) ABrABr R SMOT Table 3: The top three feature contributions to the components of the PCA (ranked by magnitude). nent feature of the PCA also suggests that whether or not the conversation is 'hub-like' is another way to distinguish conversations. 4.2 Clustering The temporal components are partitioned into five clusters shown by the den- drogram in Figure 4. We choose five clusters in particular as this maximises the silhouette score (see Appendix B.2). In Table 4 we report the average values for the features within each cluster, combining the motifs with different event types for brevity. In Figure 5 we pick a representative component from each cluster and plot the static aggregated graph of connections between nodes. Each cluster is distinct and captures some of the different types of behaviour observed on Twitter. Cluster 1. Cluster 1 boasts the highest edge density, reciprocity, and clus- 12 Feature Nnodes* Nevents* D (seconds)* ρ* ABAB Motif ABAC Motif ABBA Motif ABBC Motif ABCA Motif ABCB Motif SMOT SIET µ(in, in) µ(out, in) µ(out, out) C R λ 1 5.33 13.67 542 0.42 0.09 0.07 0.28 0.12 0.16 0.29 1.85 1.92 -0.27 0.08 0.27 0.41 0.48 0.03 Conversation Cluster 4 2 3 22.46 33.11 686 0.16 0.12 0.05 0.11 0.08 0.11 0.53 1.74 1.97 -0.55 -0.59 0.11 0.02 0.18 0.03 8.15 12.13 166 0.18 0.34 0.40 0.00 0.02 0.01 0.23 1.33 0.98 -0.79 0.42 0.83 0.02 0.00 0.57 14.49 20.21 455 0.13 0.19 0.02 0.00 0.00 0.00 0.79 0.48 1.81 -0.97 -0.93 0.91 0.00 0.00 0.06 5 13.98 16.76 751 0.15 0.16 0.08 0.01 0.01 0.02 0.71 0.68 2.04 -0.88 -0.62 0.80 0.02 0.03 0.03 *not used as a feature Table 4: Feature vector averages across clusters (pre-normalisation). For brevity, we have combined the motifs with different event types. The first, second, and third most prevalent motif in each cluster is highlighted in red, orange, and yellow respectively. tering coefficient. This cluster is therefore a candidate for what would be classi- fied as conversational behaviour; users sharing messages back and forth between each other and with conversations lasting around nine minutes. Cluster 1 also has the smallest number of nodes on average. Cluster 2. Cluster 2 consists of hybrid retweeting and message behaviour. Nodes will retweet multiple sources, but also send out messages (sometimes to accounts they have retweeted). This hybrid behaviour often leads to these hubs being connected to other hubs which results in a larger number of connected nodes. The hub nodes in these components appear to be maximising their activity on the network and exposure to other nodes, however unlike in cluster 1, this interaction is not reciprocated. Cluster 3. Cluster 3 has an exceedingly large activity rate, compared to the other clusters. This is due to it containing conversations where many users retweet one or more central bodies. Retweeting is an instantaneous action which requires little thought and so large numbers of retweets can happen in a short period of time. This cluster is also short-lived however, lasting less than three 13 e c n a t s D i 200 175 150 125 100 75 50 25 0 Temporal Component Clusters Figure 4: Dendrogram of temporal components and associated clustering. Pair- wise Euclidean distances are calculated and a hierarchy is created using Ward's method. The number of clusters is calculated by maximising the silhouette score (see text). minutes on average. Another observation we can make is the presence of 'bridge' nodes which have retweeted two or more of the central nodes. These users are potentially bringing together two different conversational topics or merely collecting tweets surrounding a single topic. Cluster 4. Cluster 4 is an example of hub-like behaviour, indicated by the extremal values of µ. A single node will retweet many other nodes with little to no other interaction. The second most prevalent motif in this cluster is ABrABr which indicates the central node is retweeting the same node multiple times. In this cluster there is little evidence of social interaction as components are primarily driven by a single node aggregating information from other nodes. Cluster 5. Cluster 5 is in some sense the opposite to cluster 4. Mul- tiple nodes message a central node, however there is little interaction in the opposite direction, or any sign of diverse behaviour (given the second lowest motif entropy). These components last substantially longer than their cluster 4 counterparts, despite having fewer events on average (751 seconds compared to 445 seconds). This is likely due to messages taking longer to compose than an instant retweet, naturally elongating the time over which we see the behaviour. 4.3 Evolution over time These prevalence of these clusters are not necessarily equal in size nor do they persist uniformly across time. Each temporal event is associated with a temporal component which is in turn associated with a cluster. In Figure 6 we plot the size of a cluster over time as a fraction of all events, aggregated by hour. Clusters 2 and 4 make up the majority of observed behaviour on the temporal network. This means that the majority of activity occurring is either single-node retweeting aggregation or a hybrid of aggregation and unreciprocated messaging. This suggests that the majority of activity on the network is driven by a small 14 (a) Cluster 1 (b) Cluster 2 (c) Cluster 3 (d) Cluster 4 (e) Cluster 5 Figure 5: Example aggregated graphs of representative temporal components from each cluster. Messages and retweets are coloured green and red respec- tively. In cluster 1, messages are sent back and forth between multiple nodes, typical of what one would associate with a conversation. Cluster 3 is associated with one or more central nodes being retweeted by a set of other nodes. Cluster 4 consists solely of a single node retweeting many other nodes, and cluster 2 exhibits similar mass retweeting behaviour combined with a small fraction of messaging, usually across a wider array of nodes. Finally, in cluster 5 many nodes message one or more central nodes. number of nodes which may occasionally interact with each other. The more conversational cluster 1 never contributes to more than 10% of activity over the course of the day, although naturally becomes more prevalent during daylight hours (for Europe and the Middle East). 4.4 Comparison with Random Ensembles The results of the clustering have highlighted the diverse behaviour on Twitter, however we still need to assess whether this diversity is significant. To do this we consider an ensemble of 200 time-shuffled samples of the data. For each sample we first create an 'complete' feature vector x∗ for the dataset by considering the entire temporal network as a single temporal component. Then for each temporal component feature vector xc we subtract off the com- 15 Cluster 1 Cluster 2 Cluster 3 Cluster 4 Cluster 5 0.5 0.4 0.3 0.2 0.1 s t n e v E f o n o i t c a r F 0.0 0000 0200 0400 0600 0800 1000 1200 1400 1600 1800 2000 2200 0000 Time (GMT) Figure 6: Cluster volumes over time as a fraction of all events, aggregated by hour. Clusters 2 and 4 are consistently dominant throughout the day, com- prising of over half of all events in total. The other clusters are less prevalent although their activity levels change over time. For example, cluster 5 becomes more prevalent between the hours of 7am and midnight (GMT). The remaining fraction of all events are those components with fewer than five events which were not part of the clustering. plete feature vector, i.e. x ′ c = xc − x∗. The average distance between the each temporal component the entire network, given by 1 C∆t Xc∈C∆t x ′ c, is a measure of the diversity of components within the network. For the ensemble of randomised networks, the mean and standard deviation are 0.648 and 0.002 respectively. In contrast, the mean of x′ for the original data is 0.70 (which comparing to the ensemble distribution equates to a z-score of 17.4). Hence we can conclude that the components features that we are measuring are significant, and are more diverse than we would expect to see at random. This also supports the decomposition of the temporal network; there are different behaviours across the nodes of the temporal network (and over time) so we may lose this diversity by considering the temporal network as a single entity. In Figure 7 we show the density of the temporal components for the original data (a) and random ensemble (b) in two dimensional feature-space, reduced by principal component analysis. The wider marginal distributions in (a) confirm our statistical analysis showing that the temporal components are more diverse 16 than random components. There do however appear to be a number of possible clusters in the randomised data. This is likely due to components with repetitive behaviour (such as in cluster 4) where the same motif will appear regardless of the ordering of events. The primary difference in the shuffled cases is that on average these components will be smaller and there will be more of them. ) % 8 2 ( 2 t n e n o p m o C 1.0 0.5 0.0 −0.5 −1.0 ) % 8 2 ( 2 t n e n o p m o C 1.0 0.5 0.0 −0.5 −1.0 −1.0 −0.5 0.5 Component 1 (44%) 0.0 1.0 −1.0 −0.5 0.5 Component 1 (44%) 0.0 1.0 (a) (b) Figure 7: Temporal component feature densities for the data (a) and an en- semble of 200 time-shuffled instances of the data (b). Feature space is reduced to two dimensions using PCA. Marginal distributions for each dimension are also shown. The original data is more diverse than the time-shuffled ensemble, although the time-shuffled data exhibits some bimodality. Finally, as well as a more homogeneous collection of temporal components, there are fewer temporal components (of minimum size five) in the random ensemble than in the original data. There are on average 3530 temporal com- ponents in the random ensembles, compared with 4137 in the original data. Interestingly, there are more events per component in the original data (21.1 compared to 13.7 on average), however the temporal components in the random ensemble are on average of a longer duration (774s for random ensemble and 536 for original data). This is likely due to the events for any temporal component being more uniformly spread in contrast to the original data where multiple events may occur within a short period of time (those in cluster 3 for example). 4.5 Comparison with Fixed-width Interval Decomposition To compare the temporal component decomposition we use a fixed-width in- terval decomposition of the temporal network. Following the same procedure outlined above, we calculate the feature vector for each time interval before rescaling and clustering. We choose the interval width to be the average com- ponent duration in the data which is 536 seconds. The interval-based clustering 17 is poor however, taking a maximal silhouette coefficient of less than 0.2 for two clusters which decreases with the number of clusters (see Figure B.2). In Figure 8 we show examples of the to most representative intervals for each cluster. Using this information alone it is difficult to distinguish any particular behaviour as by definition all the behaviour is restricted to a particular interval and will therefore overlap. Based on this evidence there is no real change in col- lective behaviour over the day long period. We can however consider a further (a) Cluster 1 (b) Cluster 2 Figure 8: Example aggregated graphs from the time-interval decomposition. The clustering method finds two overlapping clusters which are indistinguishable by eye. decomposition into the static components of each time interval. This results in 5912 different components which we can cluster, more than the 4137 from the temporal component decomposition. Clustering the interval-based components gives a better decomposition than clustering the intervals alone, however it falls short of the temporal component decomposition (based on the silhouette coef- ficient across all possible number of clusters). Furthermore the interval-based components are restricted to have a duration less than the interval width when a particular pattern of behaviour may in fact span multiple intervals. This is illustrated by considering how many temporal components span multiple inter- vals. For this particular interval width, over 60% of temporal components span multiple intervals and would therefore be split under such a method. This could lead to double-counting components, or their omission altogether if the split falls under the minimum component size threshold. In contrast for a window size of 4 minutes over 80% of temporal components are split, and for a window size of 20 minutes 37% of components are split. 18 5 Conclusion and Discussion In this article we have devised a novel way to decompose a temporal networks using both topological and temporal features. Furthermore, we combined tem- poral motifs, inter-event times, and a number of static graph features to create an embedding of the temporal components which can be used to cluster collec- tive behaviour. We applied this method to a dataset of digital communication taken from Twitter to highlight the diversity of communicative behaviour, how- ever this analysis can be easily extended to other forms of digital communication (email etc.), clickstreams, as well as to other contexts such as biological protein networks or temporal networks of proximity. There is currently not a suitable benchmark for the evaluation of temporal network embeddings, due to the limited work in this area. Furthermore, as an original object of study, the temporal components of the event graph have no direct comparison in the literature. We anticipate that the temporal net- work embedding and the use of temporal components will need to be validated independently. The use of each feature should be fully justified. In principle, the features which are not purely temporal could be captured by considering higher-order motifs. Here we have used features which capture some of these higher-order interactions (such as clustering) at a cost of approximating the temporal network by a static network. Since we are considering temporal components of small timescales (minutes), relative to the time period (1 day), this approximation is reasonable. For future work it would be enlightening to compare the trade off between computation required and the quality of clustering as we consider a balance of higher-order motifs and static approximations. One feature of this analysis that has not previously mentioned is that it can be conducted in near-real-time. This is crucial if one wants analyse event streams on timescale of minutes rather than days. This is particularly useful for Twitter where conversations are typically short-lived. The computational cost of building the event graph scales linearly with the number of events, and the features of each temporal component can then be computed in parallel. As these components are small relative to the entire network their summary statistics can be computed quickly. This allows us to monitor event streams over time and be reactive to change. Finally, we discuss the particular merits and issues within the example con- text. Developing a greater understanding of online conversations can help both companies and scientists alike understand how we behave in an online social context, and how this behaviour varies over time. This goes beyond the simple individual statistics (message counts, number of followers etc.) that are com- monplace in this area. Characterising this behaviour allows companies to tailor their activity to the type of conversation occurring and target resources where they will be most effective, potentially leading to more efficient and impactful social media campaigns and interactions. One particular context where these methods may be useful is in the identification of automated of 'bot' accounts. Current state-of-the-art methods use a number of temporal, network, and lan- 19 guage derived features [43], however they do not consider behaviour from the temporal-topological perspective of temporal motifs (or the associated entropy). In preparing this work we have also found instances where individual accounts show no abnormal behaviour, but operate systematically as a collective. As automation becomes more advanced, so too will be the tools required to detect these accounts. In this article we have considered only the network structure and have omit- ted any other associated data (such as text, photos, videos, sentiment). One possible extension would be to augment this analysis with natural language processing techniques and topical analysis to further understand what is being discussed within conversations, and whether the temporal components lie along topical boundaries. The simplest addition to this analysis would be calculating the sentiment [44, 45] of each conversation. Sentiment is unreliable for short messages and so the average sentiment of a conversation may be more enlight- ening than individual messages. Another point to consider is that this analysis is on a relatively small dataset and the results should not be generalised, the intent of this article being to showcase the method. We can apply this analysis across longer time periods and different types of data (such as email) to gain a greater understanding of the diversity of the our digital conversations and temporal networks in general. Funding This work is supported by the Oxford-Emirates Data Science Lab (OEDSL). Acknowledgements Thanks to Roxana Pamfil, Madhurima Sinha, Peter Grindrod, and Renaud Lambiotte for useful comments and discussion. Availability of data and material dataset, under The available https://github.com/empiricalstateofmind/eventgraphs. article /examples/collective behaviour paper and folder code, the notebook supporting this are at References [1] Kwak, H., Lee, C., Park, H., Moon, S.: What is Twitter, a social network or a news media? In: Proceedings of the 19th International Conference on World Wide Web, pp. 591 -- 600 (2010). ACM 20 [2] Monsivais, D., Ghosh, A., Bhattacharya, K., Dunbar, R.I., Kaski, K.: Tracking urban human activity from mobile phone calling patterns. PLoS computational biology 13(11), 1005824 (2017) [3] Onnela, J.-P., Saramaki, J., Hyvonen, J., Szab´o, G., Lazer, D., Kaski, K., Kert´esz, J., Barab´asi, A.-L.: Structure and tie strengths in mobile communication networks. Proceedings of the national academy of sciences 104(18), 7332 -- 7336 (2007) [4] Kovanen, L., Kaski, K., Kert´esz, J., Saramaki, J.: Temporal motifs re- veal homophily, gender-specific patterns, and group talk in call sequences. Proceedings of the National Academy of Sciences 110(45), 18070 -- 18075 (2013) [5] Banerjee, A., Ghosh, J.: Clickstream clustering using weighted longest common subsequences. In: Proceedings of the Web Mining Workshop at the 1st SIAM Conference on Data Mining, vol. 143, p. 144 (2001) [6] Barrat, A., Cattuto, C.: Temporal networks of face-to-face human interac- tions. In: Temporal Networks, pp. 191 -- 216. Springer, ??? (2013) [7] Pan, R.K., Saramaki, J.: Path lengths, correlations, and centrality in tem- poral networks. Physical Review E 84(1), 016105 (2011) [8] Han, J.-D.J., Bertin, N., Hao, T., Goldberg, D.S., Berriz, G.F., Zhang, L.V., Dupuy, D., Walhout, A.J., Cusick, M.E., Roth, F.P., et al.: Evi- dence for dynamically organized modularity in the yeast protein -- protein interaction network. Nature 430(6995), 88 (2004) [9] Masuda, N., Lambiotte, R.: A Guide to Temporal Networks vol. 4. World Scientific, ??? (2016) [10] Holme, P., Saramaki, J.: Temporal Networks. Springer, ??? (2013) [11] Holme, P.: Modern temporal network theory: a colloquium. The European Physical Journal B 88(9), 234 (2015) [12] Grindrod, P., Higham, D.J.: A dynamical systems view of network cen- trality. Proceedings of the Royal Society A: Mathematical, Physical and Engineering Science 470(2165), 20130835 (2014) [13] Mellor, A.: The temporal event graph. Journal of Complex Networks, 048 (2017). doi:10.1093/comnet/cnx048 [14] Kivela, M., Cambe, J., Saramaki, J., Karsai, M.: Mapping temporal- network percolation to weighted, static event graphs. arXiv preprint arXiv:1709.05647 (2017) [15] Jurgens, D., Lu, T.-C.: Temporal motifs reveal the dynamics of editor interactions in Wikipedia. In: ICWSM (2012) 21 [16] Kovanen, L., Karsai, M., Kaski, K., Kert´esz, J., Saramaki, J.: Tempo- ral motifs in time-dependent networks. Journal of Statistical Mechanics: Theory and Experiment 2011(11), 11005 (2011) [17] Hamilton, W.L., Ying, R., Leskovec, J.: Representation learning on graphs: Methods and applications. arXiv preprint arXiv:1709.05584 (2017) [18] Grover, A., Leskovec, J.: node2vec: Scalable feature learning for networks. In: Proceedings of the 22nd ACM SIGKDD International Conference on Knowledge Discovery and Data Mining, pp. 855 -- 864 (2016). ACM [19] Henderson, K., Gallagher, B., Eliassi-Rad, T., Tong, H., Basu, S., Akoglu, L., Koutra, D., Faloutsos, C., Li, L.: Rolx: structural role extraction & mining in large graphs. In: Proceedings of the 18th ACM SIGKDD Inter- national Conference on Knowledge Discovery and Data Mining, pp. 1231 -- 1239 (2012). ACM [20] Perozzi, B., Al-Rfou, R., Skiena, S.: Deepwalk: Online learning of social representations. In: Proceedings of the 20th ACM SIGKDD International Conference on Knowledge Discovery and Data Mining, pp. 701 -- 710 (2014). ACM [21] Duvenaud, D.K., Maclaurin, D., Iparraguirre, J., Bombarell, R., Hirzel, T., Aspuru-Guzik, A., Adams, R.P.: Convolutional networks on graphs for learning molecular fingerprints. In: Advances in Neural Information Processing Systems, pp. 2224 -- 2232 (2015) [22] Ikehara, K., Clauset, A.: Characterizing the structural diversity of complex networks across domains. arXiv preprint arXiv:1710.11304 (2017) [23] Nguyen, G.H., Lee, J.B., Rossi, R.A., Ahmed, N.K., Koh, E., Kim, S.: Continuous-time dynamic network embeddings. In: 3rd International Workshop on Learning Representations for Big Networks (WWW BigNet) (2018) [24] Rossi, R., Neville, J.: Time-evolving relational classification and ensemble methods. In: Pacific-Asia Conference on Knowledge Discovery and Data Mining, pp. 1 -- 13 (2012). Springer [25] Scholtes, I.: When is a network a network?: Multi-order graphical model selection in pathways and temporal networks. In: Proceedings of the 23rd ACM SIGKDD International Conference on Knowledge Discovery and Data Mining, pp. 1037 -- 1046 (2017). ACM [26] Michail, O.: An introduction to temporal graphs: An algorithmic perspec- tive. Internet Mathematics 12(4), 239 -- 280 (2016) [27] Bollen, J., Mao, H., Zeng, X.: Twitter mood predicts the stock market. Journal of Computational Science 2(1), 1 -- 8 (2011) 22 [28] Sakaki, T., Okazaki, M., Matsuo, Y.: Earthquake shakes Twitter users: Real-time event detection by social sensors. In: Proceedings of the 19th International Conference on World Wide Web, pp. 851 -- 860 (2010). ACM [29] Ramage, D., Dumais, S.T., Liebling, D.J.: Characterizing microblogs with topic models. ICWSM 10, 1 -- 1 (2010) [30] Panisson, A., Gauvin, L., Quaggiotto, M., Cattuto, C.: Mining concurrent topical activity in microblog streams. In: Proceedings of the the 4th Work- shop on Making Sense of Microposts Co-located with the 23rd International World Wide Web Conference (WWW 2014) (2014) [31] Paranjape, A., Benson, A.R., Leskovec, J.: Motifs in temporal networks. In: Proceedings of the Tenth ACM International Conference on Web Search and Data Mining, pp. 601 -- 610 (2017). ACM [32] Mellor, A.: Event graphs: Advances and applications (2018). In Prepara- tion [33] Newman, M.: Networks: An Introduction. Oxford University Press, ??? (2010) [34] Costa, L.d.F., Rodrigues, F.A., Travieso, G., Villas Boas, P.R.: Charac- terization of complex networks: A survey of measurements. Advances in physics 56(1), 167 -- 242 (2007) [35] Foster, J.G., Foster, D.V., Grassberger, P., Paczuski, M.: Edge direction and the structure of networks. Proceedings of the National Academy of Sciences 107(24), 10815 -- 10820 (2010) [36] Goh, K.-I., Barab´asi, A.-L.: Burstiness and memory in complex systems. EPL (Europhysics Letters) 81(4), 48002 (2008) [37] Lambiotte, R., Tabourier, L., Delvenne, J.-C.: Burstiness and spreading on temporal networks. The European Physical Journal B 86(7), 1 -- 4 (2013) [38] Stehl´e, J., Barrat, A., Bianconi, G.: Dynamical and bursty interactions in social networks. Physical Review E 81(3), 035101 (2010) [39] Ward Jr, J.H.: Hierarchical grouping to optimize an objective function. Journal of the American statistical association 58(301), 236 -- 244 (1963) [40] Rousseeuw, P.J.: Silhouettes: a graphical aid to the interpretation and validation of cluster analysis. Journal of computational and applied math- ematics 20, 53 -- 65 (1987) [41] Gauvin, L., G´enois, M., Karsai, M., Kivela, M., Takaguchi, T., Valdano, E., Vestergaard, C.L.: Randomized reference models for temporal networks. arXiv preprint arXiv:1806.04032 (2018) 23 [42] Maaten, L.v.d., Hinton, G.: Visualizing data using t-sne. Journal of ma- chine learning research 9(Nov), 2579 -- 2605 (2008) [43] Davis, C.A., Varol, O., Ferrara, E., Flammini, A., Menczer, F.: Botornot: A system to evaluate social bots. In: Proceedings of the 25th International Conference Companion on World Wide Web, pp. 273 -- 274 (2016). Interna- tional World Wide Web Conferences Steering Committee [44] Pang, B., Lee, L., et al.: Opinion mining and sentiment analysis. Founda- tions and Trends R(cid:13) in Information Retrieval 2(1 -- 2), 1 -- 135 (2008) [45] Pak, A., Paroubek, P.: Twitter as a corpus for sentiment analysis and opinion mining. In: LREc, vol. 10 (2010) 24 A Methods In this section we give further details on the methods used in this analysis. A.1 Event Graph Decomposition Below we outline the steps to construct the event graph and perform a temporal decomposition by thresholding the edge weights. This algorithm is implemented in the eventgraphs4 Python package, available freely online. Beginning with an empty graph: 1. For each node x construct a time-ordered sequence of events Sx = (ek)Sx k=1 such that ei ∈ Sx if and only if x ∈ {ui, vi}, i.e. the set of events for which x is a participant. 2. For each consecutive pair of events ek, ek+1 in Sx, add an edge from ek to ek+1 in the event graph with weight tk+1 − tk. Repeat this process for each node in the temporal network. The edges of the event graph can then be thresholded to removed all edges over a set value ∆t. The weakly-connected components of the event graph can then be found through standard methods by considering the corresponding undirected network. The event graph can also be constructed in real-time to address streams of event data. This can be achieved by maintaining a list of the last events that each node has participated in. Let ωx be the event which node x last participated. Upon arrival of a new event e∗ = (u∗, v∗, t∗), For each node x ∈ {u∗, v∗}, create an edge from ωx → e∗ (if ωx exists, otherwise no edge is created), and then set ωx = e∗. The arrival of a new edge can be processed by considering two lookups and is therefore an inexpensive O(1) operation. A.2 Temporal Motifs In our feature analysis we consider coloured motifs, where edges or events can be of different types, or colours. We can also consider coloured nodes (to distinguish between node types), however for this study we have no means to distinguish between nodes. This increases the number of observable motifs by a factor cn where c is the number of event colours and n is the number of events in the motif. In Figure 9 we show the four possible variations of the ABAC motif. We adopt the notation ABxACy where x and y are the motif types to describe each motif. Using coloured motifs allows us to observe more diverse behaviour that would not be captured by simply looking at the counts of each event type. In the con- text of Twitter, one behaviour that is often observed is a user being retweeted 4 https://github.com/empiricalstateofmind/eventgraphs 25 1 1 1 1 2 2 2 2 Figure 9: The four possible colourings of the ABAC motif. From left to right these are ABmACm, ABmACr, ABrACm, ABrACr. and then subsequently being messaged by the 'retweeter'. This is usually asso- ciated with the retweeter agreeing with a previous post, then adding an original contribution to the discussion. B Data In this section we justify our parameter choices for the event graph decomposi- tion and the number of clusters. B.1 Decomposition The decomposition of the temporal network using the event graph requires us to choose a value of the parameter ∆t to threshold the time between to adjacent events occurring for us to consider them to be connected. There has been little investigation into how the event graph changes with ∆t [13] and studies instead consider the sensitivity of final results to variation in the parameter. In Figure 10 we show the size (in terms of number of events) of the largest component of the event graph as a function of ∆t. We can see that there is an an abrupt growth of the largest component at approximately 360 seconds where the largest temporal component then comprises of a significant number of the events in the network. At ∆t = 3600s, or one hour, the largest component makes up a majority of all events (approximately 75%). As ∆t → ∞ the number components of the event graph converge to the number of connected components of the aggregate static graph of the entire temporal network, which in this case is 3625 (329 of them have five events or more). We therefore choose ∆t to lie in the range [0, 360] so that the number of temporal components remains high. Testing within the range around ∆t = 240 we find that the clusters found are stable. Alternatively we could have made a context specific choice for the parameter ∆t, informed by typical response times on Twitter. B.2 Number of Clusters Since we are dealing with an unsupervised clustering, we have no measure of clustering accuracy. Instead we consider the silhouette coefficient (outlined in 26 100000 c E t x a m ∆ C ∈ c 80000 60000 40000 20000 0 0 ∆t = 240 600 1200 1800 ∆t (seconds) 2400 3000 3600 Figure 10: Largest temporal size (number of events) as a function of the param- eter ∆t. The largest component experiences an abrupt transition at approxi- mately 360 seconds, after which the largest component makes up a significant fraction of the entire network (up to 75% when ∆t = 3600). We therefore chose a value of ∆t = 240 so that the component analysis is not dominated by a single giant component. the main text) which captures the distance of a sample from the centre of its assigned cluster relative to the centre of the nearest neighbouring cluster. In Figure 11 we show the silhouette coefficient for the temporal component decomposition (a) and the decomposition into intervals (b). For the temporal components the clustering is best for five clusters, although the coefficient is comparable for anywhere between 17 to 27 clusters, before seeing a sharp drop in quality for 28 clusters. This suggests that should more granularity be required (less variance within clusters) then a larger number of clusters could be chosen. In this case five clusters were chosen to simplify the presentation of the method. The interval decomposition has a different profile, showing a decreasing trend as the number of clusters increases. This suggests the best clustering is using only two clusters, however this clustering is relatively poor in comparison to the temporal component decomposition. With five or more clusters the samples are on average closer to neighbouring clusters than their assigned clusters. 27 t i n e c i f f e o C e t t e u o h l i S 0.325 0.300 0.275 0.250 0.225 0.200 0.175 0.150 0 5 t i n e c i f f e o C e t t e u o h l i S 0.20 0.15 0.10 0.05 0.00 −0.05 −0.10 15 10 Number of Clusters 20 25 30 0 5 15 10 Number of Clusters 20 25 30 (a) (b) Figure 11: Silhouette coefficients of the hierarchical clustering for the tempo- ral component decomposition (a) and the interval decomposition (b). For the temporal component decomposition the silhouette coefficient is maximal for five clusters, although a drastic drop in cluster performance occurs only at 28 clus- ters. For the interval decomposition, the silhouette coefficient is lower than most values in (a) and roughly decreases with the number of clusters. 28
1704.04278
2
1704
2018-06-24T19:37:37
Moment-based parameter estimation in binomial random intersection graph models
[ "cs.SI", "math.PR", "math.ST", "math.ST" ]
Binomial random intersection graphs can be used as parsimonious statistical models of large and sparse networks, with one parameter for the average degree and another for transitivity, the tendency of neighbours of a node to be connected. This paper discusses the estimation of these parameters from a single observed instance of the graph, using moment estimators based on observed degrees and frequencies of 2-stars and triangles. The observed data set is assumed to be a subgraph induced by a set of $n_0$ nodes sampled from the full set of $n$ nodes. We prove the consistency of the proposed estimators by showing that the relative estimation error is small with high probability for $n_0 \gg n^{2/3} \gg 1$. As a byproduct, our analysis confirms that the empirical transitivity coefficient of the graph is with high probability close to the theoretical clustering coefficient of the model.
cs.SI
cs
Moment-based parameter estimation in binomial random intersection graph models Joona Karjalainen and Lasse Leskelä Aalto University, Espoo, Finland math.aalto.fi/en/people/joona.karjalainen math.aalto.fi/~lleskela/ Abstract. Binomial random intersection graphs can be used as parsi- monious statistical models of large and sparse networks, with one pa- rameter for the average degree and another for transitivity, the tendency of neighbours of a node to be connected. This paper discusses the esti- mation of these parameters from a single observed instance of the graph, using moment estimators based on observed degrees and frequencies of 2-stars and triangles. The observed data set is assumed to be a subgraph induced by a set of n0 nodes sampled from the full set of n nodes. We prove the consistency of the proposed estimators by showing that the rel- ative estimation error is small with high probability for n0 (cid:29) n2/3 (cid:29) 1. As a byproduct, our analysis confirms that the empirical transitivity co- efficient of the graph is with high probability close to the theoretical clustering coefficient of the model. Keywords: statistical network model, network motif, model fitting, moment estimator, sparse graph, two-mode network, overlapping communities 1 Introduction Random intersection graphs are statistical network models with overlapping communities. In general, an intersection graph on a set of n nodes is defined by assigning each node i a set of attributes Vi, and then connecting those node pairs {i, j} for which the intersection Vi ∩ Vj is nonempty. When the assignment of attributes is random we obtain a random undirected graph. By construction, this graph has a natural tendency to contain strongly connected communities because any set of nodes Wk = {i : Vi (cid:51) k} affiliated with attribute k forms a clique. The simplest nontrivial model is the binomial random intersection graph G = G(n, m, p) introduced in [13], having n nodes and m attributes, where any particular attribute k is assigned to a node i with probability p, independently of other node -- attribute pairs. A statistical model of a large and sparse network with nontrivial clustering properties is obtained when n is large, m ∼ βn and p ∼ γn−1 for some constants β and γ. In this case the limiting model can be parameterised by its mean degree λ = βγ2 and attribute intensity µ = βγ. By extending the model by introducing random node weights, we obtain a statistical network model which is rich enough to admit heavy tails and nontrivial clustering properties [4,5,8,10]. Such models can also be generalised to the directed case [6]. An important feature of this class of models is the analytical tractability related to component sizes [3,15] and percolation dynamics [1,7]. In this paper we discuss the estimation of the model parameters based on a single observed instance of a subgraph induced by a set of n0 nodes. We intro- duce moment estimators for λ and µ based on observed frequencies of 2-stars and triangles, and describe how these can be computed in time proportional to the product of the maximum degree and the number of observed nodes. We also prove that the statistical network model under study has a nontrivial empiri- cal transitivity coefficient which can be approximated by a simple parametric formula in terms of µ. The majority of classical literature on the statistical estimation of network models concerns exponential random graph models [19], whereas most of the recent works are focused on stochastic block models [2] and stochastic Kronecker graphs [9]. For binomial random intersection graphs with m (cid:28) n, it has been shown [17] that the underlying attribute assignment can in principle be learned using maximum likelihood estimation. To the best of our knowledge, the current paper appears to be the first of its kind to discuss parameter estimation in random intersection graphs where m is of the same order as n. The rest of the paper is organised as follows. In Section 2 we describe the model and its key assumptions. Section 3 summarises the main results. Sec- tion 4 describes numerical simulation experiments for the performance of the estimators. The proofs of the main results are given in Section 5, and Section 6 concludes the paper. 2 Model description 2.1 Binomial random intersection graph The object of study is an undirected random graph G = G(n, m, p) on node set {1, 2, . . . , n} with adjacency matrix having diagonal entries A(i, i) = 0 and off-diagonal entries (cid:32) m(cid:88) (cid:33) A(i, j) = min B(i, k)B(j, k), 1 , k=1 where B(i, k) are independent {0, 1}-valued random integers with mean p, in- dexed by i = 1, . . . , n and k = 1, . . . , m. The matrix B represents a random assignment of m attributes to n nodes, both labeled using positive integers, so that B(i, k) = 1 when attribute k is assigned to node i. The set of attributes assigned to node i is denoted by Vi = {k : B(i, k) = 1}. Then a node pair {i, j} is connected in G if and only if the intersection Vi ∩ Vj is nonempty. 2.2 Sparse and balanced parameter regimes We obtain a large and sparse random graph model by considering a sequence of graphs G(n, m, p) with parameters (n, m, p) = (nν, mν, pν) indexed by a scale parameter ν ∈ {1, 2, . . .} such1 that n (cid:29) 1 and p (cid:28) m−1/2 as ν → ∞. In this case a pair of nodes {i, j} is connected with probability P(ij ∈ E(G)) = 1 − (1 − p2)m ∼ mp2, and the expected degree of a node i is given by E degG(i) = (n − 1)P(ij ∈ E(G)) ∼ nmp2. (2.1) Especially, we obtain a large random graph with a finite limiting mean degree λ ∈ (0,∞) when we assume that n (cid:29) 1, mp2 ∼ λn−1. (2.2) This will be called the sparse parameter regime with mean degree λ. The most interesting model with nontrivial clustering properties is obtained when we also assume that p ∼ µm−1 for some constant µ ∈ (0,∞). In this case the full set of conditions is equivalent to n (cid:29) 1, m ∼ (µ2/λ)n, p ∼ (λ/µ)n−1, (2.3) and will be called as balanced sparse parameter regime with mean degree λ and attribute intensity µ. 2.3 Induced subgraph sampling Assume that we have observed the subgraph G(n0) of G induced by a set V (n0) of n0 nodes sampled from the full set of n nodes, so that E(G(n0)) consists of node pairs {i, j} ∈ E(G) such that i ∈ V (n0) and j ∈ V (n0). The sampling mechanism used to generate V (n0) is assumed to be stochastically independent of G. Especially, any nonrandom selection of V (n0) fits this framework. On the other hand, several other natural sampling mechanisms [14] are ruled out by this assumption, although we believe that several of the results in this paper can be generalised to a wider context. In what follows, we shall assume that the size of observed subgraph satisfies nα (cid:28) n0 ≤ n for some α ∈ (0, 1). An important special case with n0 = n amounts to observing the full graph G. 1 For number sequences f = fν and g = gν indexed by integers ν ≥ 1, we denote f ∼ g if fν /gν → 1 and f (cid:28) g if fν /gν → 0 as ν → ∞. The scale parameter is usually omitted. 3 Main results 3.1 Estimation of mean degree Consider a random intersection graph G = G(n, m, p) in a sparse parameter regime (2.2) with mean degree λ ∈ (0,∞), and assume that we have observed a subgraph G(n0) of G induced by a set of nodes V (n0) of size n0, as described in Section 2.3. Then a natural estimator of λ is the normalised average degree λ(G(n0)) = n n2 0 degG(n0) (i). (3.1) (cid:88) i∈V (n0) This estimator is asymptotically unbiased because by (2.1), Eλ(G(n0)) = n n0 (n0 − 1)P(ij ∈ E(G)) ∼ λ. The following result provides a sufficient condition for the consistency of the estimator of the mean degree λ, i.e., λ → λ in probability as n → ∞. Theorem 3.1. For a random intersection graph G = G(n, m, p) in a sparse parameter regime (2.2), the estimator of λ defined by (3.1) is consistent when n0 (cid:29) n1/2. Moreover, λ(G(n0)) = λ + Op(n1/2/n0) for m (cid:29) n2 0/n (cid:29) 1. 3.2 Transitivity coefficient For a random or nonrandom graph G with maximum degree at least two, the transitivity coefficient (a.k.a. global clustering coefficient [12,16]) is defined by t(G) = 3 NK3(G) NS2 (G) (3.2) and the model transitivity coefficient by τ (G) = 3 ENK3 (G) ENS2 (G) , where NK3(G) is the number of triangles2 and NS2(G) is the number of 2-stars3 in G. The above definitions are motivated by noting that t(G) = PG( I2I3 ∈ E(G) I1I2 ∈ E(G), I1I3 ∈ E(G) ), τ (G) = P( I2I3 ∈ E(G) I1I2 ∈ E(G), I1I3 ∈ E(G) ), for an ordered 3-tuple of distinct nodes (I1, I2, I3) selected uniformly at random and independently of G, where PG refers to conditional probability given an ob- served realisation of G. The model transitivity coefficient τ (G) is a nonrandom 2 subgraphs isomorphic to the graph K3 with V (K3) = {1, 2, 3} and E(K3) = {12, 13, 23}. 3 subgraphs isomorphic to the graph S2 with V (S2) = {1, 2, 3} and E(S2) = {12, 13}. quantity which depends on the random graph model G only via its probabil- ity distribution, and is often easier to analyse than its empirical counterpart. Although τ (G) (cid:54)= Et(G) in general, it is widely believed that τ (G) is a good approximation of t(G) in large and sparse graphs [4,8]. The following result confirms this in the context of binomial random intersection graphs. Theorem 3.2. Consider a random intersection graph G = G(n, m, p) in a bal- anced sparse parameter regime (2.3). If n0 (cid:29) n2/3, then t(G(n0)) = 1 1 + µ + op(1). (3.3) It has been observed (with a slightly different parameterisation) in [8] that the model transitivity coefficient of the random intersection graph G = G(n, m, p) satisfies 1 + o(1), 1 1+µ + o(1), o(1), τ (G) = p (cid:28) m−1, p ∼ µm−1, m−1 (cid:28) p (cid:28) m−1/2, and only depends on n via the scale parameter. Hence, as a consequence of Theorem 3.2, it follows that t(G) = τ (G) + op(1) for large random intersection graphs G = G(n, m, p) in the balanced sparse parameter regime (2.3). 3.3 Estimation of attribute intensity Consider a random intersection graph G = G(n, m, p) in a balanced sparse parameter regime (2.3) with mean degree λ ∈ (0,∞) and attribute intensity µ ∈ (0,∞), and assume that we have observed a subgraph G(n0) of G induced by a set of nodes V (n0) of size n0, as described in Section 2.3. We will now introduce two estimators for the attribute intensity µ. The first estimator of µ is motivated by the connection between the empirical and model transitivity coefficients established in Theorem 3.2. By ignoring the error term in (3.3), plugging the observed subgraph G(n0) into the definition of the transitivity coefficient (3.2), and solving for µ, we obtain an estimator An alternative estimator of µ is given by µ1(G(n0)) = NS2(G(n0)) 3NK3(G(n0)) (cid:18) n0NS2(G(n0)) 2NK2(G(n0))2 µ2(G(n0)) = − 1. (cid:19)−1 , − 1 (3.4) (3.5) where NK2(G(n0)) = E(G(n0)). A heuristic derivation of the above formula is as follows. For a random intersection graph G in the balanced sparse parameter regime (2.3), the expected number of 2-stars in G(n0) is asymptotically (see Section 5) ENS2(G(n0)) ∼ 3 (mp3 + m2p4) ∼ 1 2 0µ3(1 + µ)m−2 n3 and the expectation of NK2 (G(n0)) = E(G(n0)) is asymptotically (cid:18)n0 (cid:19) 3 (cid:18)n0 (cid:19) 2 ENK2 (G(n0)) ∼ mp2 ∼ 1 2 0µ2m−1. n2 Hence ENS2(G(n0)) (ENK2 (G(n0)))2 ∼ 2 n0 (1 + µ−1), so by omitting the expectations above and solving for µ we obtain (3.5). The following result confirms that both of the above heuristic derivations yield consistent estimators for the attribute intensity when the observed sub- graph is large enough. Theorem 3.3. For a random intersection graph G = G(n, m, p) in a balanced sparse parameter regime (2.3), the estimators of µ defined by (3.4) and (3.5) are consistent when n0 (cid:29) n2/3. 3.4 Computational complexity of the estimators The evaluation of the estimator λ given by (3.1) requires computing the degrees of the nodes in the observed subgraph G(n0). This can be done in O(n0dmax) time, where dmax denotes the maximum degree of G(n0). Evaluating the estimator µ1 given by (3.4) requires counting the number of triangles in G(n0) which is a nontrivial task for very large graphs. A naive algorithm requires an overwhelming O(n3 0) time for this, a listing method can accomplish this in O(n0d2 max) time, and there also exist various more advanced algorithms [18]. The estimator µ2 given by (3.5) can be computed without the need to com- pute the number of triangles. Actually, the computation of µ2 only requires to evaluate the degrees of the nodes in G(n0). Namely, with help of the formulas (cid:88) (cid:18)degG(n0) (i) (cid:19) , i∈V (n0 ) 2 (cid:88) i∈V (n0 ) NK2(G(n0)) = 1 2 one can verify that degG(n0 )(i) and NS2 (G(n0)) = (cid:18) a2 − a1 a2 1 (cid:19)−1 − 1 , µ2(G(n0)) = (cid:80) where ak = n−1 degree distribution of G(n0). 0 i∈V (n0) degG(n0) (i)k denotes the k-th moment of the empirical We conclude that the parameters (λ, µ) of the random intersection graph G = G(n, m, p) in the balanced sparse parameter regime (2.3) can be consistently estimated in O(n0dmax) time using the estimators λ and µ2. 4 Numerical experiments In this section we study the non-asymptotic behaviour of the parameter estima- tors λ (3.1), µ1 (3.4), and µ2 (3.5) using simulated data. In the first experiment, a random intersection graph was generated for each n = 50, 70, . . . , 1000, using parameter values (λ = 9, µ = 3) and (λ = 2, µ = 0.5). All of the data was used for estimation, i.e., n0 = n. (a) λ = 9, µ = 3 (b) λ = 2, µ = 0.5 Fig. 1: Simulated values of the estimators λ, µ1, and µ2 with n0 = n. The solid curves show the theoretical values of the estimators when the feature counts N∗(G(n)) are replaced by their expected values. Fig. 2: 1000 simulated values of µ1 and µ2 with λ = 9, µ = 3, and n0 = n = 750. Figure 1 shows the computed estimates λ, µ1, and µ2 for each n. For compar- ison, the theoretical values of these estimators are also shown when the counts of 01002003004005006007008009001000n024681012^6^71^7201002003004005006007008009001000n00.511.522.533.5^6^71^7222.22.42.62.833.23.43.63.84^7122.22.42.62.833.23.43.63.84^72 links, 2-stars, and triangles are replaced by their expected values in (3.1), (3.4), and (3.5). With (λ = 9, µ = 3), the parameter µ is generally underestimated by µ1 and overestimated by µ2. The errors in µ1 appear to be dominated by the bias, whereas the errors in µ2 are mostly due to variance. With (λ = 2, µ = 0.5), the simulated graphs are more sparse. The differences between the two estimators of µ are small, and the relative error of λ appears to have increased. The disconti- nuities of the theoretical values of λ are due to the rounding of the numbers of attributes m. In the second experiment, 1000 random intersection graphs were simulated with n0 = n = 750 and (λ = 9, µ = 3). Histograms of the estimates of µ are shown in Figure 2. The bias is visible in both µ1 and µ2, and the variance of µ2 is larger than that of µ1. However, the difference in accuracy is counterbalanced by the fact that µ1 requires counting the triangles. 5 Proofs 5.1 Covering densities of subgraphs Denote by Pow(Ω) the collection of all subsets of Ω. For A,B ⊂ Pow(Ω) we denote A (cid:98) B and say that B is a covering family of A, if for every A ∈ A there exists B ∈ B such that A ⊂ B. A covering family B of A is called minimal if for any B ∈ B, (i) the family obtained by removing B from B is not a covering family of A, (ii) the family obtained by replacing B by a strict subset of B is not a covering and family of A. sets, we denote C = t and C =(cid:80)t For a graph R = (V (R), E(R)), we denote by MCF(R) the set of minimal cov- ering families of E(R). Note that all members of a minimal covering family have size at least two. For a family of subsets C = {C1, . . . , Ct} consisting of t distinct s=1 Cs. The notation R ⊂ G means that The following result is similar in spirit to [13, Theorem 3], but focused on R is a subgraph of G. subgraph frequencies instead of appearance thresholds. Theorem 5.1. If mp2 (cid:28) 1, then for any finite graph R not depending on the scale parameter, P(G ⊃ R) ∼ (cid:88) mCpC C∈MCF(R) The proof of Theorem 5.1 is based on two auxiliary results which are pre- sented first. Lemma 5.2 For any intersection graph G on {1, . . . , n} generated by attribute sets V = {V1, . . . , Vn} and any graph R with V (R) ⊂ V (G), the following are equivalent: 2 (i) R ⊂ G. (ii) E(R) (cid:98) V. (iii) There exists a family C ∈ MCF(R) such that E(R) (cid:98) C (cid:98) V. Proof. (i) ⇐⇒ (ii). Observe that a node pair e ∈(cid:0)V (cid:1) satisfies e ∈ E(G) if and only if e ⊂ Vj for some Vj ∈ V. Hence E(R) ⊂ E(G) if and only if for every e ∈ E(R) there exists Vj ∈ V such that e ⊂ Vj, or equivalently, E(R) (cid:98) V. (ii) =⇒ (iii). If E(R) (cid:98) V, define Cj = Vj ∩ V (R). Then C = {C1, . . . , Cm} is a covering family of E(R). Then test whether C still remains a covering family of E(R) if one its members is removed. If yes, remove the member of C with the highest label. Repeat this procedure until we obtain a covering family C(cid:48) of E(R) for which no member can be removed. Then test whether some C ∈ C(cid:48) can be replaced by a strict subset of C. If yes, do this replacement, and repeat this procedure until we obtain a covering family C(cid:48)(cid:48) of E(R) for which no member can be shrunk in this way. This mechanism implies that C(cid:48)(cid:48) is a minimal covering family of E(R), for which E(R) (cid:98) C(cid:48)(cid:48) (cid:98) V. (iii) =⇒ (ii). Follows immediately from the transitivity of (cid:98). Lemma 5.3 If mp2 (cid:28) 1, then for any scale-independent finite collection C = {C1, . . . , Ct} of finite subsets of {1, 2, . . .} of size at least 2, the probability that the family of attribute sets V = {V1, . . . , Vn} of G = G(n, m, p) is a covering family of C satisfies Proof. For s = 1, . . . , t, denote by Ns = (cid:80)m P(V (cid:99) C) ∼ mCpC. j=1 1(Vj ⊃ Cs) the number of at- tribute sets covering Cs. Note that Ns follows a binomial distribution with pa- rameters m and pCs. Because Cs ≥ 2, it follows that the mean of Ns sat- isfies mpCs ≤ mp2 (cid:28) 1. Using elementary computations related to the bino- mial distribution (see e.g. [13, Lemmas 1,2]) it follows that the random integers N1, . . . , Nt are asymptotically independent with P(Ns ≥ 1) ∼ mpCs, so that (cid:80)t P(Ns ≥ 1) ∼ mtp s=1 Cs.  . (cid:88) C,D P(V (cid:99) C) = P(N1 ≥ 1, . . . , Nt ≥ 1) ∼ t(cid:89)  (cid:91) P(G ⊃ R) = P s=1 Proof (Proof of Theorem 5.1). By Lemma 5.2, we see that {V (cid:99) C} C∈MCF(R) Bonferroni's inequalities hence imply U1 − U2 ≤ P(G ⊃ R) ≤ U1, where P(V (cid:99) C,V (cid:99) D), P(V (cid:99) C) and U1 = U2 = (cid:88) C∈MCF(R) and the latter sum is taken over all unordered pairs of distinct minimal covering families C,D ∈ MCF(R). Note that by Lemma 5.3, mCpC, U1 ∼ (cid:88) C∈MCF(R) so to complete the proof it suffices to verify that U2 (cid:28) U1. Fix some minimal covering families C = {C1, . . . , Cs} and D = {D1, . . . , Dt} of E(R) such that C (cid:54)= D. Then either C has a member such that Ci (cid:54)∈ D, or D has a member such that Dj (cid:54)∈ C. In the former case C ∪ D ⊃ {Ci, D1, . . . , Dt}, so that by Lemma 5.3, P(V (cid:99) C ∪ D) ≤ P(V (cid:99) {Ci, D1, . . . , Dt}) ∼ mt+1pCi+(cid:80)t ∼ mpCiP(V (cid:99) D). j=1 Dj Because C is a minimal covering family, Ci ≥ 2, and mpCi ≤ mp2 (cid:28) 1, and hence P(V (cid:99) C ∪D) (cid:28) P(V (cid:99) D). In the latter case where D has a member such that Dj (cid:54)∈ C, a similar reasoning shows that P(V (cid:99) C ∪D) (cid:28) P(V (cid:99) C). We may hence conclude that P(V (cid:99) C,V (cid:99) D) = P(V (cid:99) C ∪ D) (cid:28) P(V (cid:99) C) + P(V (cid:99) D) for all distinct C,D ∈ MCF(R). Therefore, the proof is completed by (cid:16)P(V (cid:99) C) + P(V (cid:99) D) (cid:17) ≤ 2MCF(R)U1. U2 (cid:28) (cid:88) C,D 5.2 Covering densities of certain subgraphs In order to bound the variances of subgraph counts we will use the covering densities of (partially) overlapping pairs of 2-stars and triangles. Figure 3 displays the graphs obtained as a union of two partially overlapping triangles. Figure 4 displays the graphs produced by overlapping 2-stars. Fig. 3: Graphs obtained as unions of overlapping triangles. According to Theorem 5.1, the covering densities of subgraphs may be com- puted from their minimal covering families. For a triangle R with V (R) = {1, 2, 3} and E(R) = {12, 13, 23}, the minimal covering families are4 {123} and {12, 13, 23}. The minimal covering families of the a 3-path R with V (R) = {1, 2, 3, 4} and E(R) = {12, 23, 34} are given by {1234}, {12, 234}, {123, 34}, and {12, 23, 34}. 4 For clarity, we write 12 and 123 as shorthands of the sets {1, 2} and {1, 2, 3}. Fig. 4: Graphs obtained as unions of overlapping 2-stars. The covering densities of stars are found as follows. Fix r ≥ 1, and let R be the r-star such that V (R) = {1, 2, . . . , r + 1} and E(R) = {{1, r + 1},{2, r + 1}, . . . ,{r, r + 1}}. The minimal covering families of R are of the form C = {S ∪ {r + 1} : S ∈ S}, where S is a partition of the leaf set {1, . . . , r} into nonempty subsets. For any such C we have C = S and C = r + S. Hence (cid:9) equals the number of partitions of {1, . . . , r} into k nonempty sets. k=1 k mkpk+r, These coefficients are known as Stirling numbers of the second kind [11] and can where (cid:8)r be computed via(cid:8)r k k (cid:26)r (cid:27) (cid:1)jr. Hence, P(G ⊃ r-star) ∼ r(cid:88) (cid:9) = 1 j=0(−1)k−j(cid:0)k (cid:80)k mp3 + m2p4, k! j mp4 + 3m2p5 + m3p6, mp5 + 7m2p6 + 6m3p7 + m4p8, r = 2, r = 3, r = 4. P(G ⊃ r-star) ∼ Table 1 summarises approximate covering densities of overlapping pairs of 2-stars and triangles. The table is computed by first listing all minimal covering families of the associated subgraphs, as shown in Table 2. We also use the fol- lowing observations (for p (cid:28) m−1/2 (cid:28) 1) to cancel some of the redundant terms in the expressions. 4-path: m2p7 (cid:28) m2p6 and m3p8 (cid:28) m3p7 4-cycle: m2p6 (cid:28) mp4 3-pan: m3p7 (cid:28) m2p5 Diamond: m2p6 (cid:28) mp4 and m4p9 (cid:28) m3p7 Butterfly: m5p12 (cid:28) m5p11, m4p11 (cid:28) m3p8 (cid:28) m2p6, m3p10 ≤ m3p8 (cid:28) m2p6. R 1-star 2-star 3-cycle 3-star 3-path 4-cycle 3-pan Diamond 4-star 4-path Chair Butterfly 2 3 3 4 4 4 4 4 5 5 5 5 V (R) E(R) Appr. density (p (cid:28) m−1/2 (cid:28) 1) 1 mp2 2 mp3 + m2p4 3 mp3 + m3p6 3 mp4 + 3m2p5 + m3p6 3 mp4 + 2m2p5 + m3p6 4 mp4 + 4m3p7 + m4p8 4 mp4 + m2p5 + m4p8 5 mp4 + 2m3p7 + m5p10 4 mp5 + 7m2p6 + 6m3p7 + m4p8 4 mp5 + 3m2p6 + 3m3p7 + m4p8 4 mp5 + 4m2p6 + 4m3p7 + m4p8 6 mp5 + m2p6 + 2m4p9 + 4m5p11 + m6p12 (1 + µ)µ5m−4 Appr. density (p ∼ µm−1) µ2m−1 (1 + µ)µ3m−2 µ3m−2 (1 + 3µ + µ2)µ4m−3 (1 + 2µ + µ2)µ4m−3 µ4m−3 (1 + µ)µ4m−3 µ4m−3 (1 + 7µ + 6µ2 + µ3)µ5m−4 (1 + 3µ + 3µ2 + µ3)µ5m−4 (1 + 4µ + 4µ2 + µ3)µ5m−4 Table 1: Approximate densities of some subgraphs. 5.3 Proofs of Theorems 3.1, 3.2, and 3.3 Proof (of Theorem 3.1). Denote λ = λ(G(n0)) and N = NK2 (G(n0)). Then the variance of λ is given by Var(λ) = 4 n2 n4 0 By writing (cid:88) N = e∈([n0] 2 ) we find that E N =(cid:0)n0 2 1(G ⊃ e) and N 2 = (cid:1)P(G ⊃ K2) and (cid:18)n0 E N 2 = P(G ⊃ K2)+2(n0−2) P(G ⊃ S2)+ Because the last term above is bounded by Var( N ). (cid:88) (cid:88) (5.1) 1(G ⊃ e)1(G ⊃ e(cid:48)), e∈([n0 ] 2 ) e(cid:48)∈([n0] 2 ) (cid:18)n0 (cid:19)(cid:18)n0 − 2 2 2 (cid:19) P(G ⊃ K2)2. 2 (cid:19) (cid:18)n0 2 P(G ⊃ K2)2 ≤ 2 (cid:18)n0 (cid:19) (cid:19)(cid:18)n0 − 2 (cid:18)n0 (cid:19) (cid:18)n0 Var( N ) ≤ 2 2 2 (cid:19) it follows that (cid:19)2 P(G ⊃ K2)2 = (E N )2, (cid:18)n0 2 (cid:19) P(G ⊃ S2) P(G ⊃ K2) + 2(n0 − 2) = (1 + o(1)) 1 2 n2 0mp2 + (1 + o(1))n3 0(mp3 + m2p4). C C 3-path 4 1 1234 5 2 123, 34 5 234, 12 2 12, 23, 34 3 6 C C 4-cycle 4 1 1234 6 2 123, 134 6 2 124, 234 7 3 123, 14, 34 3 7 124, 23, 34 7 3 134, 12, 23 7 234, 12, 14 3 12, 14, 23, 34 4 8 C C Diamond 4 1 1234 6 2 123, 234 7 3 123, 24, 34 7 3 234, 12, 13 8 3 124, 134, 23 4 9 124, 13, 23, 34 9 134, 12, 23, 24 4 12, 13, 23, 24, 34 5 10 C C 3-cycle 3 123 1 6 12, 13, 23 3 C C Chair 5 1 12345 6 2 1234, 45 6 2 1345, 23 6 2 2345, 13 6 2 123, 345 7 3 123, 34, 45 3 7 134, 23, 45 7 3 234, 13, 45 7 345, 13, 23 3 13, 23, 34, 45 4 8 C C 4-path 5 1 12345 6 2 1234, 45 6 2 2345, 12 6 2 123, 345 7 2 1245, 234 3 7 123, 34, 45 7 3 234, 12, 45 7 3 345, 12, 23 8 1245, 23, 34 3 12, 23, 34, 45 4 8 C C 3-pan 4 1 1234 5 2 123, 34 7 3 134, 12, 23 7 234, 12, 13 3 12, 13, 23, 34 4 8 C C Butterfly 5 1 12345 6 2 123, 345 8 3 1234, 35, 45 3 8 1235, 34, 45 8 3 1345, 12, 23 8 3 2345, 12, 13 10 3 1245, 134, 235 10 3 1245, 135, 234 9 4 123, 34, 35, 45 9 4 345, 12, 13, 23 4 11 1245, 134, 23, 25 11 4 1245, 235 ,13, 34 11 4 1245, 135, 23, 34 11 4 1245, 234, 13, 35 11 5 134, 12, 23, 35, 45 11 5 135, 12, 23, 34, 45 5 11 234, 12, 13, 35, 45 11 5 235, 12, 13, 34, 45 12 1245, 13, 23, 34, 35 5 12, 13, 23, 34, 35, 45 6 12 Table 2: Minimal covering families of the subgraphs in Fig. 3 and Fig. 4 (stars excluded). Hence by (5.1), Var(λ) = O(n−2 0 n2m2p4), and by noting that n2mp2 ∼ λn, n2mp3 = m−1/2n1/2(nmp2)3/2 ∼ λ3/2m−1/2n1/2 and n2mp4 = (nmp2)2 ∼ λ2, we find that (cid:16) 0 n2mp2) + O(n−1 0 n2mp3) + O(n−1 (cid:17) = O 0 n ≥ n−1 (cid:16) 0 n−2 0 n + m−1/2n−1 n−2 0 n + m−1/2n−1 0 . The claim now follows by 0 n1/2 + n−1 Var(λ) = O where the last equality is true because n−2 Chebyshev's inequality. Proof (of Theorem 3.2 and Theorem 3.3). The variances of NS2 and NK3 can be bounded from above in the same way that the variance of NK2 was bounded in the proof of Theorem 3.1. The overlapping subgraphs contributing to the vari- ance of NK3 are those shown in Fig. 3. According to Table 1, the contribution of m−V (R)+1) for V (R) = 3, 4, 5, and the nonover- these subgraphs is O(n 0m−2, it lapping triangles contribute O(n6 follows that Var(NK3/ENK3) = o(1) for n0 (cid:29) n2/3. 0m−5). Since ENK3 is of the order n3 V (R) 0 0 n1/2(cid:17) , The same line of proof works for NS2, i.e., we note that the subgraphs ap- pearing in Var(NS2 ) are those shown in Fig. 4 and their contributions to the variance are listed in Table 1. Again, it follows that Var(NS2/ENS2 ) = o(1) for n0 (cid:29) n2/3. Hence we may conclude using Chebyshev's inequality that µ3m−2 NK3 (G(n0)) = (1 + op(1))ENK3(G(n0)) = (1 + op(1)) (cid:18)n0 (cid:19) (cid:19) (cid:18)n0 3 NS2 (G(n0)) = (1 + op(1))ENS2 (G(n0)) = (1 + op(1))3 (1 + µ)µ3m−2, 3 and the claim of Theorem 3.2 follows. Further, in the proof of Theorem 3.1 we found that NK2(G(n0)) = (1 + op(1))ENK2(G(n0)) = (1 + op(1)) (cid:18)n0 (cid:19) 2 µ2m−1. Hence the claims of Theorem 3.3 follow from the above expressions combined with the continuous mapping theorem. 6 Conclusions In this paper we discussed the estimation of parameters for a large random in- tersection graph model in a balanced sparse parameter regime characterised by mean degree λ and attribute intensity µ, based on a single observed instance of a subgraph induced by a set of n0 nodes. We introduced moment estimators for λ and µ based on observed frequencies of 2-stars and triangles, and described how the estimators can be computed in time proportional to the product of the maximum degree and the number of observed nodes. We also proved that in this parameter regime the statistical network model under study has a nontrivial em- pirical transitivity coefficient which can be approximated by a simple parametric formula in terms of µ. For simplicity, our analysis was restricted to binomial undirected random intersection graph models, and the statistical sampling scheme was restricted induced subgraph sampling, independent of the graph structure. Extension of the obtained results to general directed random intersection graph models with general sampling schemes is left for further study and forms a part of our ongoing work. Acknowledgments. Part of this work has been financially supported by the Emil Aaltonen Foundation, Finland. We thank Mindaugas Bloznelis for helpful discussions, and the two anonymous reviewers for helpful comments. References 1. Ball, F.G., Sirl, D.J., Trapman, P.: Epidemics on random intersection graphs. Ann. Appl. Probab. 24(3), 1081 -- 1128 (2014), http://dx.doi.org/10.1214/13-AAP942 2. Bickel, P.J., Chen, A., Levina, E.: The method of moments and degree distributions for network models. Ann. Statist. 39(5), 2280 -- 2301 (2011), http://dx.doi.org/ 10.1214/11-AOS904 3. Bloznelis, M.: The largest component in an inhomogeneous random intersection graph with clustering. Electron. J. Combin. 17(1) (2010) 4. Bloznelis, M.: Degree and clustering coefficient in sparse random intersection graphs. Ann. Appl. Probab. 23(3), 1254 -- 1289 (2013), http://dx.doi.org/10. 1214/12-AAP874 5. Bloznelis, M., Kurauskas, V.: Clustering function: another view on clustering co- efficient. Journal of Complex Networks (2015) 6. Bloznelis, M., Leskelä, L.: Diclique clustering in a directed random graph. In: Bonato, A., Graham, F.C., Prałat, P. (eds.) Algorithms and Models for the Web Graph. pp. 22 -- 33. Springer International Publishing, Cham (2016) 7. Britton, T., Deijfen, M., Lagerås, A.N., Lindholm, M.: Epidemics on random graphs with tunable clustering. J. Appl. Probab. 45(3), 743 -- 756 (2008), http://dx.doi. org/10.1239/jap/1222441827 8. Deijfen, M., Kets, W.: Random intersection graphs with tunable degree distribution and clustering. Probab. Eng. Inform. Sc. 23(4), 661 -- 674 (2009), http://dx.doi. org/10.1017/S0269964809990064 9. Gleich, D.F., Owen, A.B.: Moment-based estimation of stochastic Kronecker graph parameters. Internet Math. 8(3), 232 -- 256 (2012), http://projecteuclid.org/ euclid.im/1345581012 10. Godehardt, E., Jaworski, J.: Two models of random intersection graphs and their applications. Electronic Notes in Discrete Mathematics 10, 129 -- 132 (2001) 11. Graham, R.L., Knuth, D.E., Patashnik, O.: Concrete Mathematics. Addison- Wesley (1994) University Press (2017) 12. van der Hofstad, R.: Random Graphs and Complex Networks - Vol. I. Cambridge 13. Karoński, M., Scheinerman, E.R., Singer-Cohen, K.B.: On random intersection graphs: The subgraph problem. Combin. Probab. Comput. 8(1-2), 131 -- 159 (1999), http://dx.doi.org/10.1017/S0963548398003459 14. Kolaczyk, E.D.: Statistical Analysis of Network Data. Springer (2009) 15. Lagerås, A.N., Lindholm, M.: A note on the component structure in random in- tersection graphs with tunable clustering. Electron. J. Combin. 15(1), Note 10, 8 (2008), http://www.combinatorics.org/Volume_15/Abstracts/v15i1n10.html 16. Newman, M.E.J.: The structure and function of complex networks. SIAM Review 45(2), 167 -- 256 (2003), http://dx.doi.org/10.1137/S003614450342480 17. Nikoletseas, S., Raptopoulos, C., Spirakis, P.G.: Maximum cliques in graphs with small intersection number and random intersection graphs. In: International Sym- posium on Mathematical Foundations of Computer Science. pp. 728 -- 739. Springer (2012) 18. Tsourakakis, C.E.: Fast counting of triangles in large real networks without count- ing: Algorithms and laws. In: 2008 Eighth IEEE International Conference on Data Mining. pp. 608 -- 617 (Dec 2008) 19. Wasserman, S., Faust, K.: Social Network Analysis: Methods and Applications. Cambridge University Press (1994)
1805.02039
2
1805
2019-05-24T11:46:01
Integration in Social Networks
[ "cs.SI", "physics.soc-ph" ]
We propose the notion of $k$-integration as a measure of equality of opportunity in social networks. A social network is $k$-integrated if there is a path of length at most $k$ between any two individuals, thus guaranteeing that everybody has the same network opportunities to find a job, a romantic partner, or valuable information. We compute the minimum number of bridges (i.e. edges between nodes belonging to different components) or central nodes (those which are endpoints to a bridge) required to ensure $k$-integration. The answer depends only linearly on the size of each component for $k=2$, and does not depend on the size of each component for $k \geq 3$. Our findings provide a simple and intuitive way to compare the equality of opportunity of real-life social networks.
cs.SI
cs
Equality of Opportunity and Integration in Social Networks∗ Josu´e Ortega Center for European Economic Research (ZEW), Mannheim, Germany. May 27, 2019 Abstract We propose the notion of k-integration as a measure of equality of opportunity in social networks. A social network is k-integrated if there is a path of length at most k between any two individuals, thus guaranteeing that everybody has the same network opportunities to find a job, a romantic partner, or valuable infor- mation. We compute the minimum number of bridges (i.e. edges between nodes belonging to different components) or central nodes (those which are endpoints to a bridge) required to ensure k-integration. The answer depends only linearly on the size of each component for k = 2, and does not depend on the size of each component for k ≥ 3. Our findings provide a simple and intuitive way to compare the equality of opportunity of real-life social networks. KEYWORDS: social integration, social networks, equality of opportunity. ∗E-mail address: [email protected]. 1. Relevance Our social networks are highly clustered, meaning that it is common to observe com- munities that are very densely connected within themselves but only poorly so with the rest of the social network (Watts and Strogatz, 1998; Traud et al., 2012; Mishra et al., 2007). The people in each community usually share particular characteristics, such as race, ethnicity or educational background. For example, the average Ameri- can public school student has less than one school friend of another race (Fryer, 2007). Among White Americans, 91% of people comprising their social networks are also White (Cox et al., 2016). Among British students who live in highly multicultural residences, less than 5% nominates a South-American, West Indian, Oriental or Middle Easterner among their three best friends (Furnham and Alibhai, 1985). Social networks are also highly clustered by religion, political views, and education, among other characteristics (Louch, 2000). The fact that we are segregated into these poorly interconnected societies has signif- icant consequences. Many important decisions such as who we marry, who we work for, and what information we obtain crucially depend on who we know or who our friends and our acquaintances know. We are incredibly likely to marry someone within our extended social circles (at least until the emergence of online dating, see Rosenfeld and Thomas, 2012 and Ortega and Hergovich, 2017). It is also well-documented that over 50% of jobs are obtained through social contacts (Rees, 1966; Corcoran et al., 1980; Granovetter, 1973, 1995), and that the connections we possess may explain the observed drop-out rates of the labor force (Topa, 2001; Calv´o-Armengol and Jackson, 2004). Fur- thermore, our social circle determines the information to which we are exposed to online (Bakshy et al., 2012), our sexual partners (Ergn, 2002) and how scientists collaborate in their research projects (Barabsi et al., 2002; Farkas et al., 2002). Therefore, the lack of connections between communities can forbid that some agents interact with oth- ers, making them lose potential job opportunities, valuable information, or potential romantic partners. In this paper, we study the minimum number of inter-community connections re- quired so that every agent in the social network has access to the entire social network, thus guaranteeing that every agent has the same networking opportunities. To do so, we assume that each agent can only interact with another agent who is connected to her within k steps, i.e. connected by a path of length at most k. For example, k = 1 2 means that agents can only interact (work, marry, communicate, etcetera) with people whom they directly know. Similarly, k = 2 means that agents can interact with people who they either know directly, or with whom they have a friend in common, and so on. Given k, the question we ask is how many connections between communities (which we call bridges) are required to guarantee that any two people in the social network are k-connected, i.e. that the underlying graph has diameter k? And how many agents must know someone outside their community, i.e. how many agents must be central? In this paper, we provide answers to both questions for all values of k as a function of the number and the size of the communities conforming a social network. We obtain tight values, which guarantee that if we remove one bridge or one central agent, there In this must be at least two nodes that are not connected by a path of length k. case, we say that the social network fails to be k-integrated. Because we study lower bounds on the number of bridges and nodes, we impose without loss of generality that every community is completely connected within, i.e. the corresponding graph of each community is complete. The notion of k-integration for social networks that we propose, which requires that any two nodes are connected by a path of at most length k, is inspired by the well- known literature of equality of opportunity in philosophy and economics (Roemer, 2009; Arneson, 2015). If a social network is k-integrated, every agent would have the same access to job opportunities, information, romantic partners, and so on, irrespective of their location within the network and the community to which the agent belongs. Our results allow us to identify when a social network fails our proposed criterion of opportunity fairness in networks, which is parametrized by k, simply by either counting the number of connections between communities or the number of agents who have such connections. It also allows us to compare social networks on the basis of k-integration. We find that the number of bridges (Bk) and central agents (Ck) needed for k- integration quickly diminishes as k becomes larger, and does not depend on the size of each community for k ≥ 3. To give an example, consider a social network with 8 com- munities, each containing 1,000 agents. For 1−integration, we require 28 million bridges and 8,000 central agents, whereas for 2−integration we only require 7,000 bridges and 7,001 central agents. Furthermore, for 3−integration we only require 28 bridges and 8 central agents. The intuition behind our result is that as k grows, the externalities generated by each bridge and central node increase. It is nevertheless surprising that the externalities generated by each bridge are so large that, to cover such a large social 3 network with k = 3, we only need 0.00010% of the total possible bridges and 0.1% of the total nodes to be central. Figure 1 provides an illustration of a social network with 8 communities with 9 agents each. (a) B1 = 2268, C1 = 72 (b) B2 = 63, C2 = 64 (c) B3 = 28, C≥3 = 8 (d) B4 = 12 (e) B5 = 10 (f) B6 = B8 = 8 (g) B≥9 = 7 Figure 1: Minimal k-integrated social networks with 8 communities of 9 agents each. Bridges and central nodes appear in blue. Communities are indicated with dashed triangles. The size and location of nodes are irrelevant and for exposition only. Each community has a complete graph: some of these intra-community edges do not appear to improve readability. Our result is related to the small world phenomenon in Watts and Strogatz (1998). They note that regular graphs (those in which all nodes have the same number of neigh- bors) are highly clustered but exhibit long characteristic path lengths. On the contrary, random graphs in which edges are created independently at random, have short char- acteristic path lengths but are not clustered. However, if we start from a regular graph and we randomly rewire each edge with some probability, we quickly obtain a graph that is both highly clustered and exhibit short characteristic path lengths, two properties of many real-life networks.1 Our result is similar to theirs in spirit, but instead of looking at characteristic or expected path lengths, we strictly require that each path length is 1Barth´el´emy and Amaral (1999) show that the appearance of small-world behavior is not a phase- transition but a crossover phenomenon. 4 at most k. Although a random graph may exhibit a short characteristic path length, it may still have a few edges that are very poorly connected to the rest of the social network. Thus, our integration measure ensures that all agents are well-connected to the network, unlike expected or characteristic path length. We quantify the specific number of bridges and central nodes needed to ensure that all paths are of length at most k. Ortega and Hergovich (2017) also obtain a similar result using random graphs, which they use to analyze the impact of online dating in the number of interracial marriages. They show that for k ≥ 2, a few bridges can quickly make a social network 2-integrated, leading to a fast increase in the number of agents who decide to marry interracially. Their model's prediction is consistent with observed demographic trends. In this paper, we focus instead on deterministic graphs and compute the minimal number of bridges and central nodes required to guarantee k-integration for all values of k. This paper contributes to explaining the fast increase of interracial marriages in their model, by showing that just a few bridges can ensure that the society is k-integrated for k ≥ 2. Furthermore, it provides an easy way to check whether a social network may experience such an integration change.2 There is a vast literature on efficiently computing the exact value of k (i.e the diameter) in arbitrary social networks, which is a substantially more general problem; see Aingworth et al. (1999) and references therein. 2. Definitions and Model Basic Definitions. An undirected graph or network3 is an ordered pair F = (N, E) consisting of a set of nodes N = {a, b, c, . . .} and a set of edges E = {ab, ac, . . .}. The set of edges consists of unordered pairs of nodes. Two nodes a, b are adjacent if ab ∈ E, and we say that a and b are the endpoints of edge ab. A graph in which every two different nodes are adjacent is called complete. A graph F ′ = (N ′, E ′) is a supergraph of F if N ⊆ N ′ and E ⊆ E ′. Two graphs are disjoint if they share no nodes. A path from node i to t is a vector of edges (ij, jk, . . . , qs, st) such that every consecutive edges share an endpoint. The path length is the number of edges 2In general, making a graph more connected can reduce some desirable properties of the graph (Ortega, 2019, 2018). 3We use both terms indistinctly. 5 in a path. The distance between two nodes is the length of the shortest path between them. Two graphs are connected if there exists a path between any of their nodes, and disconnected otherwise. Model. We consider r disjoint complete graphs K1 = (N1, E1), K2 = (N2, E2), . . . , Kr = (Nr, Er), all with n nodes. Each complete graph is called a local graph, and its edges are called local edges. A global graph G = (NG, EG) is a supergraph of the union r r of all local graphs, so that Ni ⊆ NG and S i=1 S i=1 Ei ⊆ EG. The notation Ki ∪ Kj denotes the supergraph (Ni ∪ Nj, Ei ∪ Ej). We assume n ≥ r. A supergraph is equivalent to the islands network structure proposed by Golub and Jackson (2012) which, in their words, "is surprisingly accurate as a description of some friendship patterns". A bridge is an edge of a global graph whose endpoints belong to different local graphs.4 A node is central if its an endpoint of a bridge. B and C denote the number of bridges and central nodes in a global graph, respectively. Figure 2 presents an example of a global graph with two bridges and four central nodes. Figure 2: A global graph with n = 4, r = 3, B = 2 and C = 4. We propose the following notion of integration for global graphs. Definition 1 (Integration in Graphs). A global graph is k-integrated if there exists a path of length at most k between any two nodes. A global graph that is not k-integrated is k-segregated. 4The standard definition of a bridge is an edge whose removal would disconnect the graph (Diestel, 2017). Nevertheless, we redefine this term to make exposition clearer. 6 This paper studies the minimum number of bridges and central agents that a global graph or network requires to be k-integrated. These are presented in the following Theorem. 3. Result Theorem 1. A global graph is k-segregated if B < Bk or C < Ck. The values for Bk and Ck are given in the table below and are tight, i.e. for any values of r and n there exist a k-integrated global graph with B = Bk and C = Ck. k 1 2 3 ... r + 1 Bk n2r(r − 1)/2 (r − 1)n r(r − 1)/2 Ck rn (r − 1)n + 1 r f (r) r − 1 r r where f (r) is a function of r that does not depend on n. We separate the proof into three parts. First, we show that a global graph is k- segregated if B < Bk. Second, we show that a global graph is k-segregated if C < Ck. Third, we show that one can always construct a k-integrated local graph with exactly Bk bridges and Ck central nodes, for any values of r and n. Proof of Minimality of Bk. For k = 1, order all local graphs randomly. Each node in the first local graph needs to be adjacent to n nodes in each of the (r − 1) local graphs. Each node in the second local graph needs to be connected to n nodes in each of the remaining (r − 2) local graphs, and so on. A simple computation yields n r−1 X i=1 i · n = n2 r(r − 1) 2 (1) For k = 2, we start by showing the following Lemma: Let A = (N1, E1) and B = (N2, E2) be two disjoint graphs with n1 and n2 nodes. Then Bk = min(n1, n2). Otherwise, there are two nodes x ∈ N1, y ∈ N2 such that both are not central. Thus, it is impossible to make a path of length at most 2 connecting x and y. 7 Now we show that the global graph must have B2 = (r − 1)n by constructing such a graph. Start with a global graph containing all r local graphs K1, K2, . . . , Kr and no bridges. To ensure that every node in K1 is 2-integrated to K2 we need n bridges, by the previous Lemma. Similarly, we need n bridges to 2-integrate K1∪K2 and K3 (remember that we started from a graph with 0 bridges), n bridges to 2-integrate K1 ∪ K2 ∪ K3 r−1 and K4, ..., and n bridges to 2-connect Ki and Kr. This is the minimal number of S i=1 bridges we need to construct to ensure that the graph is 2-connected. In fact, if the bridges are created in a particular way, we do not need any bridges connecting any two local graphs Ki, Kj for i 6= j 6= 1. We show this when presenting an example showing that this bound is tight in part 3 of the proof. For k = 3, assume that two local graphs K1 and K2 are not directly connected by a bridge, i.e. ∄x ∈ K1, y ∈ K2 such that xy ∈ B. Then, for that graph to be 3-integrated, all the n nodes of K1 must be directly connected to a local graph K3 that is connected to K2 by a bridge. Thus, for each two local graphs that are not directly connected, we need n bridges. Now suppose that all but one local graph are directly connected by a bridge. The total number of bridges is n + (r−1)(r−2) , whereas if every two local graphs were directly connected by a bridge the total number of bridges would be r(r−1) quick computation makes evident (recall n ≥ r) that . A 2 2 r(r − 1) 2 < n + (r − 1)(r − 2) 2 (2) Finally, for k > 3, note that Bk ≥ Bk+1. Therefore, Bk ≤ r(r−1) 2 for k > 3, which is itself a function of r which does not depend on n. Finally, note that for k = r + 1, we need at least a path between any two nodes. This means that all but two local graphs must be directly connected by a bridge to at least one other local graph. If Br+1 < r −1, then there are two local graphs that are not connected by any path, a contradiction. This concludes the proof of minimality of Bk. Now we show that a global graph is k-segregated if C < Ck. Proof of Minimality of Ck. For k = 1 every agent needs to be central so the proof is trivial. For k = 2, suppose by contradiction that there are only (r − 1)n central nodes in a 2-integrated global graph, i.e. there are n non-central nodes. Then either all those non- 8 central nodes belong to a whole local graph, which is then disconnected from the rest of the global graph (a contradiction), or there are two nodes from different local graphs that are not central. The shortest path between those has length 3, a contradiction. For k ≥ 3 the proof is also trivial: if there are less than r central nodes then at least one local graph is disconnected from the rest of the global graph. Finally, we provide examples of global graphs that are k-integrated with exactly B = Bk and C = Ck, showing that these values are tight. Proof of Sufficiency of Bk and Ck. For k = 1, we trivially require that every node is central and that any two nodes belonging to different communities are directly con- nected by a bridge (see subfigure 1a in the Introduction). For k = 2, we can achieve the lower bounds B2 = (r − 1)n and C2 = (r − 1)n + 1 by selecting one local graph that has only one central node. This node connects to all other nodes of different communities, and by our assumption also to every node in his own community. This way we create a "2-integrated star graph" which is by construction 2-integrated. An example appears in Figure 3 (and in subfigure 1b in the Introduction). Figure 3: A 2-integrated star graph with B2 = (r − 1)n and C2 = (r − 1)n + 1. For k = 3, we can achieve the lower bounds B3 = r(r − 1)/2 and C3 = r by selecting one node from each local graph, which will be the only central node belonging to his community. This node is connected to all other central nodes of each other local graph. Therefore, we create a complete graph among each of the r central nodes. We call the corresponding global graph an "extended star graph". An example appears in Figure 4. For k-integrated graphs for k ≥ 3, Ck remains equal to r whereas Bk keeps decreasing up to r − 1. Figure 2 in the Introduction shows how to construct the corresponding 9 Figure 4: A 3-connected extended star graph with B3 = r(r−1) 2 and C3 = r. k-integrated graphs. When k = r + 1, if there exist r − 1 bridges connecting the r central nodes, there is a path from any two central nodes with length at most r − 1. In an extended star graph, this implies that the maximum distance between any two nodes is r + 1, and thus the graph becomes (r + 1)-integrated, as depicted in subfigure 1g. Acknowledgements I am indebted to an anonymous referee for helpful comments and to Sarah Fox and Vanessa Schller for proofreading the paper. References Aingworth, D., C. Chekuri, P. Indyk, and R. Motwani (1999): "Fast estima- tion of diameter and shortest paths (without matrix multiplication)," SIAM Journal on Computing, 28, 1167 -- 1181. Arneson, R. (2015): "Equality of opportunity," in The Stanford Encyclopedia of Philosophy, ed. by E. Zalta. 10 Bakshy, E., I. Rosenn, C. Marlow, and L. Adamic (2012): "The role of social networks in information diffusion," in Proceedings of the 21st International Confer- ence on World Wide Web, ACM, 519 -- 528. Barabsi, A.-L., H. Jeong, Z. N´eda, E. Ravasz, A. Schubert, and T. Vicsek (2002): "Evolution of the social network of scientific collaborations," Physica A: Statistical mechanics and its applications, 311, 590 -- 614. Barth´el´emy, M. and L. A. N. Amaral (1999): "Small-world networks: Evidence for a crossover picture," Physical Review Letters, 82, 3180. Calv´o-Armengol, A. and M. Jackson (2004): "The effects of social networks on employment and inequality," American Economic Review, 94, 426 -- 454. Corcoran, M., L. Datcher, and G. J. Duncan (1980): "Most workers find jobs through word of mouth," Monthly Labor Review, 103, 33 -- 35. Cox, D., J. Navarro-Rivera, and R. Jones (2016): "Race, religion, and political affiliation of Americans core social networks," Tech. rep., Public Religion Research Institute, 2013 American Values Survey. Diestel, R. (2017): Graph theory, Springer. Ergn, G. (2002): "Human sexual contact network as a bipartite graph," Physica A: Statistical Mechanics and its Applications, 308, 483 -- 488. Farkas, I., I. Dernyi, H. Jeong, Z. Nda, Z. Oltvai, E. Ravasz, A. Schubert, A.-L. Barabsi, and T. Vicsek (2002): "Networks in life: scaling properties and eigenvalue spectra," Physica A: Statistical Mechanics and its Applications, 314, 25 -- 34. Fryer, R. (2007): "Guess who's been coming to dinner? Trends in interracial marriage over the 20th century," Journal of Economic Perspectives, 21, 71 -- 90. Furnham, A. and N. Alibhai (1985): "The friendship networks of foreign students: A replication and extension of the functional model," International Journal of Psy- chology, 20, 709 -- 722. Golub, B. and M. Jackson (2012): "How homophily affects the speed of learning and best-response dynamics," Quarterly Journal of Economics, 127, 1287 -- 1338. 11 Granovetter, M. (1973): "The strength of weak ties," American Journal of Sociol- ogy, 78, 1360 -- 1380. -- -- -- (1995): Getting a job: A study of contacts and careers, University of Chicago Press, University of Chicago Press. Louch, H. (2000): "Personal network integration: transitivity and homophily in strong-tie relations," Social Networks, 22, 45 -- 64. Mishra, N., R. Schreiber, I. Stanton, and R. Tarjan (2007): "Clustering social networks," in Algorithms and Models for the Web-Graph, ed. by A. Bonato and F. Chung, Springer, 56 -- 67. Ortega, J. (2018): "Social integration in two-sided matching markets," Journal of Mathematical Economics, 78, 119 -- 126. -- -- -- (2019): "The losses from integration in matching markets can be large," Eco- nomics Letters, 174, 48 -- 51. Ortega, J. and P. Hergovich (2017): "The strength of absent ties: Social integra- tion via online dating," arXiv preprint 1709.10478. Rees, A. (1966): "Information networks in labor markets," American Economic Re- view, 56, 559 -- 566. Roemer, J. (2009): Equality of opportunity, Harvard University Press. Rosenfeld, M. and R. Thomas (2012): "Searching for a mate: The rise of the Internet as a social intermediary," American Sociological Review, 77, 523 -- 547. Topa, G. (2001): "Social interactions, local spillovers and unemployment," Review of Economic Studies, 68, 261 -- 295. Traud, A., P. Mucha, and M. Porter (2012): "Social structure of Facebook networks," Physica A: Statistical Mechanics and its Applications, 391, 4165 -- 4180. Watts, D. and S. Strogatz (1998): "Collective dynamics of "small-world" net- works," Nature, 393, 440. 12
1102.1753
2
1102
2011-02-11T14:12:30
Predictors of short-term decay of cell phone contacts in a large scale communication network
[ "cs.SI", "physics.soc-ph", "stat.ML" ]
Under what conditions is an edge present in a social network at time t likely to decay or persist by some future time t + Delta(t)? Previous research addressing this issue suggests that the network range of the people involved in the edge, the extent to which the edge is embedded in a surrounding structure, and the age of the edge all play a role in edge decay. This paper uses weighted data from a large-scale social network built from cell-phone calls in an 8-week period to determine the importance of edge weight for the decay/persistence process. In particular, we study the relative predictive power of directed weight, embeddedness, newness, and range (measured as outdegree) with respect to edge decay and assess the effectiveness with which a simple decision tree and logistic regression classifier can accurately predict whether an edge that was active in one time period continues to be so in a future time period. We find that directed edge weight, weighted reciprocity and time-dependent measures of edge longevity are highly predictive of whether we classify an edge as persistent or decayed, relative to the other types of factors at the dyad and neighborhood level.
cs.SI
cs
Predictors of short-term decay of cell phone contacts in a large scale communication network$,$$ Troy Raedera, Omar Lizardob,∗, David Hachenb, Nitesh V. Chawlaa aDeparment of Computer Science and Engineering, College of Engineering, University of Notre Dame, 384 Fitzpatrick Hall, Notre Dame, IN, 46556 bDeparment of Sociology, University of Notre Dame, 810 Flanner Hall, Notre Dame, IN, 46556 Abstract 1 1 0 2 b e F 1 1 ] I S . s c [ 2 v 3 5 7 1 . 2 0 1 1 : v i X r a Under what conditions is an edge present in a social network at time t likely to decay or persist by some future time t + ∆t? Previous research addressing this issue suggests that the network range of the people involved in the edge, the extent to which the edge is embedded in a surrounding structure, and the age of the edge all play a role in edge decay. This paper uses weighted data from a large-scale social network built from cell-phone calls in an 8-week period to determine the importance of edge weight for the decay/persistence process. In particular, we study the relative predictive power of directed weight, embeddedness, newness, and range (measured as outdegree) with respect to edge decay and assess the effectiveness with which a simple decision tree and logistic regression classifier can accurately predict whether an edge that was active in one time period continues to be so in a future time period. We find that directed edge weight, weighted reciprocity and time-dependent measures of edge longevity are highly predictive of whether we classify an edge as persistent or decayed, relative to the other types of factors at the dyad and neighborhood level. Keywords: edge persistence, edge decay, link prediction, dynamic networks, embeddedness, tie strength, weighted networks 1. Introduction Under what conditions are particular social connections more or less likely to dissolve over time? Most network analysts agree that the issue of the dynamic stability of social rela- tionships embedded in networks is a fundamental one (Suitor et al., 1997; Wellman et al., 1997; Feld et al., 2007; Bidart $Research was sponsored in part by the Army Research Laboratory and was accomplished under Cooperative Agreement Number W911NF-09-2-0053 and in part by the National Science Foundation (NSF) Grant BCS-0826958. The views and conclusions contained in this document are those of the authors and should not be interpreted as representing the official policies, either expressed or implied, of the Army Research Laboratory or the U.S. Government. The U.S. Government is authorized to reproduce and distribute reprints for Government purposes notwithstanding any copyright notation hereon. $$We would like to thanks the Social Networks editors and two anonymous reviewers for helpful comments and suggestions which served to significantly improve a previous version of this manuscript. ∗Corresponding Author. and Degenne, 2005). One obvious reason for the centrality of relationship dynamics is that essentially all of the classic behavioral theories in the network tradition -- such as balance (Heider, 1958; Davis, 1963) and exchange theory (Emerson, 1972) -- can be productively considered theories about the rela- tive likelihood that some edges will persist and other edges will be dissolved (Hallinan, 1978). For instance, classic balance- theoretic analyses of the dynamics of reciprocity suggest that the reason why we are more likely to observe tendencies to- ward reciprocity in human social networks is precisely because unreciprocated edges have a shorter lifespan -- they are more likely to be dissolved by the unreciprocated party -- and are thus weeded out of the network through a selection process (Halli- nan, 1978; Tuma and Hallinan, 1978; Hallinan and Hutchins, 1980; Hallinan and Williams, 1987; van de Bunt et al., 1999; van Duijn et al., 2003). A similar line of reasoning is behind Granovetter's (1973) influential "strength of weak edges" argu- Preprint submitted to Social Networks October 25, 2018 ment: the reason why the intransitive "forbidden triad" is rare, is precisely because dyads embedded in fully-reciprocated tri- ads are expected to be less likely to decay over-time (Davis, 1967) -- a proposition that has received some empirical confir- mation by Burt (2000). While much attention has been paid to the emergence of transitivity in social networks through a process of meeting through an intermediary, it is clear that thinking dynamically about the persistence of transitivity in social networks -- through the selective dissolution of relation- ships not embedded in triads -- transforms this to a problem of accounting for the structural precursors of edge decay. This also implies that empirically "bridges" across transitive clus- ters should decay at a faster rate than other types of edges (Burt, 2002). In addition to these theoretical considerations, there are sev- eral substantive and practical motivations for the attempt to make progress in predicting edge persistent decay and persis- tence. First, at the level of the whole network, edge decay may signal changing community structure (Tantipathananandh et al., 2007). From an ego-centric perspective, if a given actor experi- ences high-levels of volatility and decay in her current relation- ships this may indicate that he or she is moving between peer groups or undergoing a major life change (Suitor and Keeton, 1997; Feld et al., 2007; Bidart and Lavenu, 2005). Second, rela- tionships that are identified as likely to decay may under some circumstances (e.g. when there is a need to binarize a weighted matrix) be better thought of as "false positives." In passively- collected behavioral data such as email and cell phone com- munications (Kossinets, 2006; Hidalgo and Rodriguez-Sickert, 2008) -- the source of data on which we rely in the analysis below -- the notion of what exactly constitutes an edge is some- what unclear. Being able to predict edge decay may shed light on the circumstances under which an edge can be considered as "real" for the purposes of further analysis. More recently, with the increasing availability of longitudi- nal social network data, the temporal evolution of social net- works is beginning to receive increasing attention (Burt, 2000, 2002; Wellman et al., 1997; Bidart and Degenne, 2005; Bidart and Lavenu, 2005). This has been aided by the recent develop- ment of actor-oriented, stochastic approaches for the analysis of longitudinal network data (van de Bunt et al., 1999; Sni- jders, 2005) which couple the evolution of micros-structures with agent-level attributes and behavioral outcomes (see Sni- jders et al. (2010) for a recent review). However, in spite of its centrality for the main lines of the- ory in network analysis, the dynamics of link decay remains a relatively understudied phenomenon, especially at the level of behavioral observation. In this respect, the main roadblock to a better understanding of the dynamics that drive patterns of de- cay of social edges in networks has been the relative paucity of large-scale, ecologically reliable data on social interactions (Ea- gle et al., 2008). The methodological and measurement issues associated with dynamic network data collected from informant reports on who they are connected to are well-known and well- documented, so there is no need extensively rehearse them here (Bernard et al., 1984; Krackhardt, 1987). These include: (1) systematic measurement error introduced by constraints on va- lidity due to informant recall biases (Brewer, 2000; Brewer and Webster, 2000; Marin, 2004), (2) measurement constraints in- troduced due to reliance on so-called fixed-choice designs to accommodate for respondent's memory limitations and stamina (Feld and Carter, 2002; Kossinets, 2006), and (3) validity lim- its introduced by data collection strategies that are limited (due to cost and the relative obtrusiveness of sociometric question- naires) to small samples constrained to specific sites (Laumann et al., 1989) (4) limitations in the ability to measure the volume and frequency of communicative activity that flows through an edge, with most studies being relegated to using standard bi- nary networks in which links are thought to be either present or absent (Opsahl and Panzarasa, 2009; Hammer, 1985). In the decay and formation dynamics of social relationships, these well-known limitations acquire renewed importance for three reasons. First, as large-scale (sometimes containing thousands -- and in our case millions -- of actors) data on human communication begins to accumulate, examining the extent to which standard analytic approaches can be used to account for 2 empirical dynamics in this domain becomes a primary concern. Second, when considering the issue of link decay, the prob- lem of biases produced by memory limitations, artificial up- per bounds on actor's degree produced by survey design stric- tures and the selective reporting of those contacts most subjec- tively (or objectively) important becomes an issue of substan- tive and methodological significance (Holland and Leinhard, 1973; Kossinets, 2006; Kossinets and Watts, 2006). For while it is unlikely that persons will misreport being connected to those with whom they interact most often (Hammer, 1985; Freeman et al., 1987), by selectively collecting data on ego's strongest edges, it is likely that survey-based methods may give undue consideration to precisely those links that are least likely to de- cay. Finally, ignoring the fact that most real-world communica- tion networks are not binary -- each edge is instead "weighted" differently depending on the amount of communicative activity that flows through it (Barrat et al., 2004) -- can impose artificial limits on our ability to predict which links are more likely to de- cay and which ones are more likely to remain. In this paper we use behavioral network data on a large-scale sample of commu- nicative interactions -- obtained unobtrusively from cell-phone communication records -- to study the dynamic and structural processes that govern link decay. One advantage of the data that we use below is the fact that it consists of weighted links based on dyadic communication frequency It is of course not our intention to suggest that data obtained from cellular communication records are themselves devoid of bias or that previous research using self-report data do not con- stitute a solid foundation on which to build. In fact, we rely on research and theory from such studies in the analysis that follows. Cellular communication data are certainly not a direct reflection of the underlying social network. Communicating by phone is only one out of a large menu of possible ways in which two persons may be connected; and in fact may persons can share strong connections without necessarily talking over the phone. In addition just like informants may fail to mention their least important ties, rare-behavioral events (e.g. contact- ing somebody whom you only talk to once a year) will also be absent from observational data unless really long observation windows are used, thus producing a similar observational bias keyed to relative strength. It is our contention however, that data obtained from sponta- neous behavioral interactions will produce dynamical patterns that may be closer to those that govern the formation, suste- nance and decay of human social relationships in "the wild" (Hammer, 1985). As such, they are an important resource to establish the structural and dynamic properties of large-scale social networks.We already know that data of this type have high ecological validity, in that cell-phone mediated interaction accurately predicts face-to-face interaction and self-reported friendship as measured using traditional sociometric methods (Eagle et al., 2009). With penetration rates close to 100% in industrialized countries such as the one from which these data were collected (Onnela et al., 2007), cell-phone communica- tions are also generally devoid of the socio-demographic biases that plagues studies that rely on modes of communication that have yet to achieve comparable levels of universal usage (such as email or chat). Onnela et al. (2007) examined basic topolog- ical properties of a cell-phone communication network similar to ours, and found it to display some basic signatures specific to social networks (e.g. small mean-path length, high-clustering, community structure, large-inequalities in connectivity across vertices, etc.). This paper makes several contributions to the literature. First, on the substantive side, we incorporate insights and mecha- nisms from previous studies of network evolution to understand processes of link decay. In addition we bring into considera- tion dyad-level process -- such as degree of reciprocity -- that have not yet been considered in studies of edge decay (mostly due to the fact that the data used are binary and not weighted). On the methodological side, we introduce supervised learning tech- niques from the computer science literature for the study of so- cial network evolution. These techniques are appropriate for discovering patterns in data of the size and scope with which we are faced here (millions of persons and tens of millions of communication events), both extending and complement- 3 ing the more traditional regression-based techniques that have been used to tackle this problem in the existing literature (e.g Burt, 2000, 2002). Machine learning algorithms allow us to as- certain the relative importance of individual, dyadic and local- structural information in contributing to lowering or increasing the likelihood of link decay without incorporating strong as- sumptions about functional form -- they are "non-parametric" in this respect -- or homogeneity of effect sizes across the rele- vant feature space. The remainder of the paper is organized as follows: In the following section we briefly review previous research on edge decay in social networks. In Section 3 we connect the substan- tive concern with identifying the factors that lead to link decay in the social networks with the largely methodological literature related to the link prediction problem in computer science and explain how we partially adapt these tools to the task at hand. In Section 4 we go on to review previous work on the dynam- ics of social relationships in large-scale networks. In Section 5 we describe the data on which we conducted this study and for- mally define each of the problems we consider. Section 7 de- scribes basic topological and distributional features of our main predictors. In Section 8 we examine the correlation structure among the network features that we choose for the prediction task. In Section 9 we present the results, identifying which net- work features are the strongest predictors of edge decay. In Section 10 we analyze the classifier's performance and explore their comparative fit. Finally in Section 11 we discuss the sub- stantive implications of our results, draws conclusions, and lay out potential avenues for future research. the network or individuals sever edges. The most exemplary work on the issue of edge decay in social networks is that of Burt (2000, 2002), who studies the social networks of promi- nent bankers over time and analyzes the factors that contribute to the disappearance of edges. Specifically, prominent bankers within an organization were asked, once a year for four years, to name other bankers from the same organization with which they had had "frequent and substantial business contact" over the previous year. Two main substantive conclusions emerge from this analysis: 1. Several factors influence edge decay, including homophily (similarity between people), embeddedness (mutual ac- quaintances), status (e.g. network range), and experience. 2. Links exhibit a "liability of newness", meaning that newly- formed links decay more quickly than links that have ex- isted for a long time. These observations seem to lay out a framework for predict- ing link decay (and by implication, link persistence), and that is precisely the chief question of this paper: What are the vertex- level, dyad-level and local-structural features that can be used to most accurately predict edge decay? A formal statement of this research question gives rise to what we will call the decay prediction problem: Given the activity within a social network in a time period τ1, how accurately can we predict whether a given edge will persist or decay in a following window τ2? In what follows we evaluate the effectiveness of a machine learn- ing solution to the decay prediction problem. 3. The Link Prediction Problem 2. Correlates of Edge Decay in Social Networks A great deal of effort has gone into characterizing the growth of networks, either with high-level generative models (see (Chakrabarti and Faloutsos, 2006) for a survey) or by analyz- ing the formation of individual links (Hays, 1984; Marmaros and Sacerdote, 2006). Comparatively little work has been done on decay dynamics in large-scale networks with an already ex- isting structure: the processes by which individual actors leave The problem of decay prediction is intimately related to the link prediction problem. There are several related but slightly different problems that are termed "link prediction" in the com- puter science literature. The most related one, originally studied by Liben-Nowell and Kleinberg (2007) can be stated as follows: given the state of a network G = (V, E) at time t, predict which new edges will form between the vertices of V in the time inter- val τ = (t, t + ∆t). See (Bilgic et al., 2007; Clauset et al., 2008) 4 for additional work in this vein or (Getoor and Diehl, 2005) for a survey. Other authors (Kashima and Abe, 2006) have formulated the problem as a binary classification task on a static snapshot of the network, but this version of the problem is less related to the present effort simply because it is not longitudinal in na- ture. Current research on link prediction in computer science focuses mostly on evaluating the raw predictive ability of differ- ent techniques, by either incorporating different vertex and edge attributes (O'Madadhain et al., 2005; OMadadhain et al., 2005; Popescul and Ungar, 2003) or the selecting different learning methods (Hasan et al., 2005) in order to improve prediction per- formance. Where we differ from this work, apart from address- ing a slightly different problem, is that we attempt to system- atically characterize the attributes that lead to successful clas- sification. In other words, rather than being concerned simply with whether, or to what extent, our models succeed or fail, we attempt to characterize why they are successful or unsuccess- ful by measuring the importance of different attributes and of weighted edge data to classification. 4. Previous longitudinal research on large-scale networks Several authors have studied the evolution of large networks and identified characteristics that are important to the forma- tion of edges. Kossinets and Watts (2006) studied the evolu- tion of a University email network over time and the extent to which structural properties, such as triadic closure, and ho- mophily contribute to the formation of new edges. Of particular relevance to us, they find that edges that would close triads are more likely to form than edges that do not close triads, and that people who share common acquaintances are much more likely to form edges than people who don't. Similarly, Leskovec et al. (2008) study the evolution (by the arrival of vertices and the formation of edges) of four large online social networks and conclude, among other things, that triadic closure plays a very significant role in edge formation. Both of these factors are re- lated to the notion of embeddedness which we study in the con- text of edge decay, but neither of these authors consider edge decay at all. Marsili et al. (2004) develop a model for network evolution that allows for the disappearance of edges, but they do not validate the model on any real-world data. As a result, the extent to which social networks fit the model is unclear and it does not shed any light on the mechanisms behind edge decay. The effort that is closest to ours in principle is a paper by Hi- dalgo and Rodriguez-Sickert (2008), which analyzes edge per- sistence and decay on a mobile phone network very similar to our own. However, the analysis undertaken below differs criti- cally from theirs both in methodology and primary focus. The aforementioned paper relies on a highly circumscribed set of well-established physical network statistics (i.e. degree, clus- tering coefficient) as well as reciprocity to explain decay. In what follows, we consider time-dependent properties of edges (Burt, 2000) as well as features associated with interaction fre- quency (edge weight) (Marsden and Campbell, 1984; Hammer, 1985; Barrat et al., 2004). 5. Data and features 5.1. Data Our primary source of data in this study consists of informa- tion on millions of call records from a large non-U.S. cell phone provider. The data include, for each call, anonymized informa- tion about the caller and callee (i.e. a consistent index), along with a timestamp, duration, and the type of call (standard call, text message, voicemail call). Our original dataset is composed primarily of phone calls and text messages. In the empirical analysis that follows, however, we restrict ourselves to dyadic communications that take the exclusive form of a voice call (we exclude text messages). We exclude all vertices with more that fifty neighbors, to ensure that only persons (and not auto-dialing robots) are represented in our data. Our final dataset consists of all in-network phone calls made over a 8-week period in 2008. We restrict our attention to in- network calls (where both the caller and callee use our provider) because we only have information about calls initiated by our provider's customers. That is to say, if i is on the network but j 5 Statistic Average Clustering Coefficient (di >= 2): Median Clustering Coefficient: Average Out-Degree: Median Out-Degree: Average Total Degree: Median Total Degree: Number of Vertices: Number of Edges: Value 0.24 0.14 4.2 3 6.3 3 4,833,408 16,564,958 Table 1: Basic graph-statistics of the cell-phone network. is not, we know if and when i calls j, but not if and when j calls i. In order to accurately predict the decay of edges, we need to be able to capture the degree of reciprocity in the relationship, meaning we need to be able to see if and when j calls i back. Thus, we only examine edges where both i and j use our cell phone provider. 5.2. Connectivity Criterion Naturally, we represent this information as a directed social network, where the vertices are the individual subscribers. An edge exists from actor i to actor j if i has at least one voice communication with j during an initial window τ1 = (t, t + ∆t), which we define as τ1 = 4weeks. Using this connectivity criterion, we identify approximately 16.5×106 directed edges in the network (see Table 1). Edges can be either bi-directional or directed arcs, depending upon whether j made a call back to i during τ1. Table 1 shows some basic topological statistics of the observed graph. 5.3. Features Using the connectivity structure of the network constructed from the first four-weeks of data, we extract a number of vertex- level, dyad-level and higher-order features based on the intu- itions provided by previous research and theory on relationship dynamics (e.g. Hallinan, 1978; Burt, 2000; Feld et al., 2007), especially as they pertain to behavioral networks with weighted edges (Hammer, 1985; Barrat et al., 2004). These features are given in Table 2 and can be grouped into four categories or sets: vertex, dyadic, neighborhood, and temporal features.1 5.3.1. Vertex-level features The vertex-level features include the outdegrees of i and j (di and d j), and the overall communicative activity of each vertex (ci and c j), that is the overall number of calls made by each member of the dyad during the 4-week time period, respec- tively. 5.3.2. Dyad-level features The dyadic level features include the directed arc strength, i.e. the counts of the number of voice calls made by i to j (ci j), and the number of calls made by j to i, ci j. We also compute normalized versions of arc strength (pi j and pi j) which are sim- ply the proportion of all calls made by an agent that go to that neighbor, where pi j = ci j/ci. 5.3.3. Neighborhood-level features The neighborhood-level features include (1) the number of common neighbors between i and j (cn), (2) directional ver- sions of the number of common neightbors (in and jn) which indicate the number of i's (or j's) neighbors that called j (or i), and (3) second order embededness features (in jn and jnin) 1We do not include any homophily-based features in this analysis, as we do not yet have reliable customer demographic information for the time period in question. 6 which measure the number of edges among i and j's neighbors. in jn does this by counting as an edge calls made from one of i's neighbors to one of j' neighbors, while jnin considers an edge as existing when one of j' neighbors calls one of i's neighbors. 5.3.4. Temporal features Finally we look at two features related to the (observed) tem- poral evolution of dyadic communicative behavior: f date cap- tures edge newness as indicated by the time of the first call from i to j during our temporal window τ; f date marks far into our time window, τ, we first observe a call from i to j. Higher val- ues indicate newer edges, while smaller values indicate older edges. The second temporal feature, edate, captures the edge freshness as indicated by the time of the last call made by i to j, given that the edge has already been observed to exist. Higher values indicate that the edge was active in the more recent past, while smaller values indicate that the edge has been inactive for a longer period of time. To the best of our knowledge, prior work has not consid- ered the freshness of an edge as a predictor of persistence/decay, though edge newness has been seen as as an important predic- tor of short-term decay via Burt's isolation of the phenomenon of the "liability of newness" of social ties (Burt, 1997, 2000). We believe that the freshness of an edge could be an important predictor as it indicates how current the edge is and we expect that more current edges are more relevant in the immediate fu- ture. If persistence or decay are partly a markov process with a relatively short memory, then edge-freshness should emerge as an important predictive factor. 5.4. Edge-decay and edge-persistence criterion We use these features to build a model for predicting whether edges fall into two disjunctive classes: persistent or decayed. For the purposes of this analysis an edge is said to persist if it is observed to exist in the time period τ2 = (t+∆t, t+∆t+∆t(cid:48)) given that it was observed in the previous time period τ1 = (t, t + ∆t) using the same connectivity criterion outlined in section 5.2 above. Conversely, an edge is said to have decayed if it was observed to exist in τ1 = (t, t + ∆t) but it can longer be detected 7 in τ2 = (t + ∆t, t + ∆t + ∆t(cid:48)) using the same operational crite- rion.2 Note that the observation and criterion periods are evenly divided such that τ1 = τ2 = 4weeks (see Figure 1). 6. Machine-Learning models for the edge-classification problem Having obtained a set of structural features from the network built from the information observed in τ1, our final task is to build a model that will allows us to most effectively assign each edge to either the persistent or decayed class using the criterion outlined in section 5.4 above. Given the large scale of our com- munication network, we turn to methods from data-mining and machine-learning to accomplish this task. We proceed by arranging the available data as a set of in- stances or examples, each of which is observed to belong to a given class, which in our case is either persistent or decayed. As we noted above, associated with each instance is a set of fea- tures or attributes. The task is to build a generalizable model from the available data. In our case, since our class takes only the value 0 (decayed) or 1 (persistent), we need to derive a func- tion F : x → {0, 1} which predicts (with some ascertainable accuracy) the class of an attribute given a vector of features X. After building the model, we need to validate its effective- ness on a set of instances that are different from those used to build the model. Typically this is done by dividing the available data into two disjoint subsets (the horizontal line in Figure 1). The first subset, called the training data, is used to build the model. Once the model is built, we use it to predict the class of each instance in the test data. The effectiveness of the model, 2We believe that a 4 week period is a long enough time window for deter- mining edge persistence/decay at least in the short to medium term. While tech- nically an edge could be inactive during this period and reappear afterwards, all indications are that very few edges are like this, and those that are are very weak and fleeting. While we could have lengthened the τ2 time period, this would have meant shortening the τ1 period, but doing so would have affected our estimates of edge features that we use in the analysis. Given that we have a total time window of τ1 + τ2 = 8weeks, we decided that the best strategy is to divide the period in half and define decay as the non-occurrence of voice calls between i and j in the second time period. Figure 1: Diagram of the data-splitting procedure used to generate basic features and to determine dyadic class-membership in the analysis below. then, depends on its accuracy (or some other measure of per- formance) on the test data. As shown in Figure 1, the data are split within each time period (τ1, τ2) into training and test sub- sets. In the analysis reported below, we randomly designated 2/3 of the original examples in the data in the first period to the training set and used the remaining 1/3 of the data as the testing set. The figure also shows the number of dyads in testing and training set that ended up in the decayed class (about 43%). 6.1. The decision-tree classifier There are a number of potential models available for evalu- ating the effectiveness of our chosen features at predicting edge decay. Perhaps the simplest of these, which was used in Burt's analysis (Burt, 2000), is simple regression: plotting each fea- ture as the independent variable against the probability of de- cay. Such an approach has the distinct advantage that it is easy to interpret. Regression is of course one of many classification tools available and also has the advantage of relative ease of in- terpretation. In what follows we present results obtained from both a logistic regression classifier (which provides easily inter- pretable output that can be compared with previous research on the subject) and a decision-tree classifier which is an approach that has not been used very often in the analysis of Social Net- works.3 While relatively unfamiliar in the analysis of social networks, the decision tree is the most well-known and well- researched method in data-mining and provides output that is easily translatable into a set of disjoint "rules" for (probabilis- tically) assigning different cases to one of the two outcomes. In our case we are interested in what combination of features maximize either edge decay or edge persistence. Because read- ers may not be wholly familiar with the decision-tree classifier approach, we provide a brief introduction to the basics of the approach before presenting the results. We presume that read- ers are familiar with the basics of logistic regression so we will not discuss it in detail. A decision tree classifies examples with a hierarchical set of rules. A decision tree model is built by recursively dividing the feature space into purer (more discriminating) subspaces along 3An important consideration with machine learning methods, as with sta- tistical methods, is the choice of model to which we attempt to fit the data. A nearly boundless series of models has been developed in the literature (Witten and Frank, 2005), and a discussion of the merits of each is well beyond the scope of this paper. Instead, we will discuss one of the models we chose (a decision tree model called C4.5 (Quinlan, 1993)) and its relative strengths for the problem at hand. 8 (a) (b) Figure 2: (a) Toy classification dataset. (b) Resulting decision tree splits that are parallel to the feature axes. A very simple exam- ple is shown in Figure 2. Given the task of classifying unknown points as either blue circles or red squares (Figure 2(a)), a deci- sion tree trained on the data points shown will produce a series of splits along the two dimensions in the figure (x and y). Gen- erally, the first split is along whichever attribute is deemed to be the best separator of the classes according to some measure. Our implementation of C4.5 determines the "best" split using information gain (which we will formally define in Section 9 below). Our hypothetical decision tree makes its first split along the line down the middle of the figure (x = 5) A tree induction algorithm will then recursively divide up each of the resulting subspaces until some stopping criterion (i.e. a minimum number of instances per leaf or minimum leaf purity) is met. Figure 2(b) shows the decision tree gen- erated by the splits corresponding to the "data" in the left-hand side. Unknown instances are classified by taking the appro- priate branches of the tree until a leaf is reached. The class assigned to the unknown instance is whichever class was most common among the training instances at that leaf. The Figure shows that any instance with x > 5 and y > 10 is classified as a red square, while everything else is a blue circle. The pri- mary advantage of decision trees for our decay prediction task (besides, of course, reasonable performance) is interpretability. Examining the classification accuracies at the individual leaves, we can see where the model is strong and where it is weak. Ad- ditionally, decision trees enable us to show that the importance of the features defined in Table 2. 6.2. Outline of the empirical analysis In what follows, we consider the following three empirical issues within our chose time window (τ): 1. Feature correlation: In the initial time window τ1 = (t, t + ∆t), what is the correlation structure of the features shown in Table 2 ? 2. Feature predictiveness: Having observed the network in a time window τ1 = (t, t + ∆t), which features of the network are most predictive of the class membership of each edge (persistent/decayed) in the adjacent time window τ2 = (t + ∆t, t + ∆t + ∆t(cid:48))? 3. Edge-class Prediction: Given a set of feature-predictors from the initial time window τ1 = (t, t + ∆t), can we build a model that accurately predicts the class membership of the edges observed in the following time window τ2 = (t + ∆t, t + ∆t + ∆t(cid:48))? After briefly considering some basic descriptive statistics on each of the predictor features in the next section, in section 8 we shed light on the first question by examining the pairwise Spearman correlation coefficients (ρ) among all pairs of fea- tures in Table 2; in section 9 we address the second question 9 (a) Outdegree of i (b) Outdegree of j (c) N. of calls made by i (d) N. of calls made by j (e) Calls from i to j (f) Calls from j to i (g) Prop. of i → j calls (h) Prop. of j → i calls (i) N. of common neighbors (j) N. of i s neighbors that call j (k) N. of j s neighbors that call i (l) N. of calls from i → j's neighbors (m) N. of calls from j → i's neighbors (n) Time of first call from i to j (o) Time of last call from i to j Figure 3: Cumulative distributions of the features included in the analysis. 10 0102030405000.511.522.5x 106d1count0102030405000.511.522.5x 106d2count100101102103104100101102103104105106c1count10−1100101102103104100101102103104105106c2count00.20.40.60.81100101102103104105106107ccicount10−1100101102103104100101102103104105106107cjicount00.20.40.60.81100101102103104105106107pijcount00.20.40.60.81100101102103104105106107pjicount01020304050100101102103104105106107cncount0510152025303540100101102103104105106107incount0510152025303540100101102103104105106107jncount050100150200250300100101102103104105106107injncount050100150200250300100101102103104105106107jnincount107.7107.71105106107fdatecount107.7107.71105106107edatecount Feature Description Range Median vertex Level di d j ci c j Dyad Level ci j c ji pi j p ji Triad Level cn in jn in jn jnin temporal f date edate Out degree of i (Ego-network Range) Out degree of j (Ego-network Range) Number of calls made by i (gregariousness) Number of calls made by j (gregariousness) Calls from i to j (directed edge strength) Calls from j to i (reciprocated edge strength) Proportion of is calls that go to j (ci j/ci) Proportion of j s calls that go to i (c ji/c j) Number of common neighbors between i and j (edge embededness) Number of is neighbors that call j (directed edge embededness) Number of j s neighbors that call i (directed edge embededness) Number of calls that i's neighbors make to j 's neighbors (2nd order embededness) Number of calls that j 's neighbors make to i's neighbors (2nd order embededness) 1-49 0-49 1-1366 0-1366 1-1341 0-1341 0-1 0-1 0-46 0-39 0-39 0-274 0-274 2 1 22 22 2 1 0.15 0.08 0 1 0 7 6 Normalized time of first call from i to j (edge newness) Time of last call from i to j (edge freshness) 0-1 0-1 0.26 0.74 Table 2: List of features to be used in predicting edge persistence/decay i → j. using an information-theoretic measure of randomness for pre- dicting short-term decay. Finally Section 10 addresses the fi- nal question by formulating the edge-decay prediction task as a binary classification problem using a machine learning data analysis strategy. 7. Feature statistics The range and median values on the features are computed based on data from the first 4 week time period and summary statistics are provided in Table 2. As shown in Figure 6.1 of the distributions are highly skewed with substantially more lower than higher values so we report medians. As noted earlier we omit edges with vertices which have degrees greater than or equal to 50 in order to eliminate robot calling, so vertex degree ranges from 1-49. Note that we have included asymetric edges, 11 that is edges in which i called j during τ1, but j did not return a call during that time period, so there are nil values for d j, c j, and c ji. i > 0 and dout j During this τ1 period the median outdegree for the focal ver- tex i is 2, but for its paired vertex j 1 because of the presence of asymmetric edges in which dout = 0. The me- dian value for the number of calls made by subscribers is 22. At the dyad level, the median number of calls from i to j is 2, but from j to i it is 1, again because of asymmetric edges. c ji, therefore should be viewed as an indicator or reciprocity in that it indicates the extent to which vertex j makes calls to i given that i made at least one call to j. pi j and p ji are normalized versions of ci j and c ji respectively and indicate what proportion of the total calls made by the ith subscriber went to each of its j neighbors. The median value of pi j of 0.15 indicates that for Figure 4: Spearman Correlation (ρ) between pairs of features in one week of call data. the edge at the middle of the pi j distribution about 15% of its total calls went to its neighbor. Turning to the neighborhood-level features, the vertices joined by the median edge do not share a common neighbor as indicated by the median value of 0 for cn. There appears to be a good deal more embeddedness when we measure it in terms of the edges between i and j's neighbors instead of directed edges from i's (or j's) neighbors to j (or i); the neighbors of vertices joined by the median edge are expected to make about seven calls to one another. Finally for the two temporal features we have normalized them so their values range from 0-1. Values on f date and edate indicate where, in the 4 week time period, the relevant events occurred. For f date, the newness of the edge, the median value is .26 indicating that 50% of the edges were active (a call had been made from i to j) at or before about one week had elapsed. For edate, the freshness of an edge, the me- dian value of .74 indicates that for 50% of the edges the last call was made by i to j before three weeks had transpired. 8. Feature correlations Figure 4 shows the Spearman correlations that capture the association between features during the first four week time pe- riod. A number of very strong correlations (shaded red -- for 12 positive correlations -- and blue -- for negative correlations -- in the figure) are immediately apparent. Among the vertex level features, degree (di or d j) and gregariousness (ci or c j) are highly correlated (.76 and .80) indicating that vertices with more neighbors make more calls. Among the dyadic level fea- tures the normalized and raw features of directed edge weight are correlated given that the normalized measure (pi j) is a func- tion of the raw measure (ci j). The correlation between ci j and c ji is positive indicating the presence of reciprocity, that is as the number of calls from i to j increases so does the number of calls from j to i. However this correlation is not extremely high, indicating that dyads do vary in their level of reciprocity. Among the neighborhood-level features, the correlations are positive and for the most part large, which could indicate that the simplest measure of embeddedness, the number of common neighbors (cn), is a good enough measure and one does not need to look at directional or second-order embeddedness. Finally it is interesting to note that the two temporal features, f date and edate, are independent. edges that are relatively older (i.e. a call occurred earlier in the 4 week time period) can be more or less current. Looking at the correlations across the various categories of the features, what is striking is how low they are. For the most Feature Description Info. Gain di d j ci c j ci j c ji pi j p ji in jn cn jnin in jn f date edate Degree of i. Degree of j. Calls made by i. Calls made by j. Calls from i to j. Calls from j to i. Proportion of i's calls that go to j Proportion of j's calls that go to i. Number of i's neighbors that call j. Number of j's neighbors that call i's neighbors. Number of common neighbors between i and j. Number of j's neighbors that call i's neighbors. Number of i's neighbors that call j's neighbors. Time of first call from i to j. Time of last call from i to j. 0.00235 0.00234 0.01181 0.00449 0.17948 0.12823 0.13318 0.12043 0.02478 0.02303 0.02441 0.01501 0.00493 0.05104 0.09954 Table 3: Information gain of each feature for predicting short-term edge decay using four weeks of data. The information gain measures the conditional ability of that feature to predict edged decay in the subsequent week within levels of the other features. part vertex, dyadic, neighborhood and temporal features are in- dependent from each other. One exception to this pattern is the correlation between outdegree (di or d j) and the normal- ized edge weight features, pi j or p ji. This has to be the case because the sum of the pi j's for a give i is 1, so the more neigh- bors a person has, the lower the proportion of their calls going to each neighbor must be (the so-called bandwidth/range trade- off (Aral and Van Alstyne, 2007)). Another exception to the pattern of low correlations between features in different cate- gories, is the high correlations between outdegree (and gregari- ousness) and the second order embeddedness features, in jn and jnin. Agents that have more neighbors are also going to have more edges between their neighbors and the neighbors of the other vertices to which they are connected. As such our second order embeddedness features essentially reduce to indicators of vertex range. Finally, the two "temporal" features, f date and edate are correlated with edge weight (ci j and to a less extent c ji). Recall that f date features the newness of an edge and that lower values are indicative of older edges. The negative corre- lation of f date with ci j indicates, therefore, that newer edges are weaker and older edges are stronger. The positive correla- tion of edate with ci j indicates that fresher edges (i.e. edges in which a call has been made more recently) are also stronger. In sum, it appears that there are really four relatively indepen- dent sets of edge features pertaining to vertex, dyadic, neighbor- hood and temporal levels. While there are multiple indicators within each of these sets, they tend to be highly correlated, with the exception of the two "temporal" features. Though in the re- mainder of the paper we will be looking at the predictive value of all these features, based on these correlations our focus will be on the following potentially important features: outdegree (both di and d j), edge weight (ci j), reciprocated edge weight (c ji), the number of common neighbors (cn), and both the new- ness of the edge ( f date) and its freshness (edate). 13 9. Feature Predictiveness We wish to determine the extent to which each of the above features as observed in the first time window helps us classi- fies edges as either decayed or persistent in the following time- window. By determining this, we can quantify, to some extent, the usefulness of the features for decay prediction. There are several possible indicators of predictive ability. Here we rely on the information gain, which is the standard measure of fea- ture predictiveness in data-mining (Witten and Frank, 2005). Approaches to determine the importance of predictors based on information theory are common in statistics (Menard, 2004; Gilula and Haberman, 2001). Information-theoretic approaches have been applied before in the characterization of overall struc- tural features of social networks (e.g. (Butts, 2001; Leydes- dorff, 1991); here they are deployed in the interest of quantify- ing the predictive ability of fine-grained (local) structural fea- tures for the link prediction problem. 9.1. Formal definition of Information Gain Information gain tracks the decrease in entropy associated with conditioning on an attribute, where entropy is a measure of the randomness (alternately, predictability) of a quantity. To understand the measure and how it quantifies feature impor- tance, consider as an example our two-class cell phone dataset, where each edge is either persistent (class 1) or decayed (class 0). If we define p(x) as the proportion of instances of class 1 and q(x) as the proportion of class zero, the entropy H(x) is defined as: H(x) = −p(x) log p(x) − q(x) log q(x) (1) where all logarithms are taken to base 2. If the two classes are perfectly balanced, then the entropy H(x) = log 2 = 1. As the classes become increasingly imbalanced, the entropy de- creases. That is to say, we know more a priori about the class of a random instance. If a particular feature is informative, then conditioning on that feature should decrease the entropy of the dataset. Suppose, for example, that a feature F takes a set K of possible values. The conditional entropy of the dataset condi- tioned on the feature F is: (cid:88) k∈K H(xF) = −pk(x) log pk(x) − qk(x) log qk(x) (2) Where pk(x) = p(class = 1F = k) is the proportion of positive-class instances among the instances where the fea- ture F takes the value k. Similarly, qk(x) is the proportion of negative-class instances. The information gain for the feature F is the decrease in entropy achieved by conditioning on F: I(xF) = H(x) − H(xF) K . Returning to our hypothetical example, suppose there is a feature F that takes on two values: A and B. Instances with F = A are 90% class 1 and instances with F = B are 90% class 0, then I(F) = log 2 − (− 9 10) = 0.530. The information gain I(xF) has an appealing intuitive interpre- tation as the percentage of information about the class that is revealed by the feature F. By calculating the information gain of each feature in Table 2, we can determine which actor and edge attributes reveal the most information about edge decay. 10 − 1 10 log 9 10 log 1 9.2. Feature Importance in the Call Network Table 3 shows the information gain of each feature described in Table 2 calculated for the first four weeks of data. The re- sults show that the four most predictive features are dyadic features of directed tie strength as given by the frequency of interaction and the extent to which communications are con- centrated on a given alter: number of calls sent and received along the edge (ci j and c ji) and call proportions from both i to j and j to i. There is a substantial drop-off in the informa- tion gain produced by the remaining features. After the dyadic- level features, the most important predictors are associated with the observed age of the tie and the recency of communication ( f date and edate, respectively). Here we observe that time of first call between i and j (edge newness) is only about half as predictive as the time of last call between i and j (edge fresh- ness) ((I(decay f date) = 0.05 versus (I(decayedate) = 0.10), suggesting that freshness beats newness as a predictive crite- rion. These are followed, in terms of predictive ability, by the 14 neighborhood-level (e.g. number of common neighbors and frequency of interaction among neighbors of the two members of the dyad) and the vertex-level features. The predictiveness afforded by either vertex or neighborhood level features is com- paratively minimal. These results suggest that previous research on tie decay, which has for the most part been unable to consider the strength of individual ties (as it has limited itself to binary network data), may have missed the most critical single factor for tie decay. This raises the question: Do features that have previously been deemed important (such as embeddedness, newness, and range actually drive tie decay or are they merely correlated surrogates for tie strength and therefore appear important only when con- crete measures of strength are absent? 10. Predicting edge persistence and decay 10.1. Classifier comparison Table 4 summarizes the performance of our two classifiers under all four prediction scenarios. It presents four stan- dard performance metrics: accuracy, precision, recall, and F- Measure. Accuracy is the proportion of all instances that the model correctly classifies. The other three metrics measure the types of error made by the classifier. Recall gives the proportion of observed persistent ties that the model correctly classifies as persisting while precision gives the proportion of ties that the model predicted as belonging to the persistent class that actu- ally did persist. Precision and recall, to some extent, measure two competing principles. Theoretically, a model could achieve very high recall by classifying all ties as persistent, but such a model would have very low precision. Similarly, a model could achieve perfect precision by classifying only its most confident instance as positive, but in doing so, it would achieve very low recall. The F-Measure captures the trade-off between precision and recall. This is defined as the harmonic mean of precision (P) and recall (R): F = 2PR P + R (3) 15 where P is the precision and R is the recall of the model in question. We evaluate both classifiers on both the majority class, per- sistence (57% of dyads), and the minority class, decay (43%). A classifier is expected to do better on the majority class be- cause there is more available data with which to build the pre- diction. As shown in the first two columns of Table 4, the decision-tree classifier performs reasonably well in regards to the majority class: it correctly predicts 73.7% of all ties (accu- racy) and 75.4% of all persisting ties (recall). In regards to the minority class, decay, the decision-tree classifier does a little bit worse. The decision-tree classifier correctly predicts 71.4% of all decaying ties. The model is also less precise when it comes to predicting decay. About 68.4% of ties predicted to decay do in fact decay, while in the case of persistence about 78% of the ties that the model predicts persist do in fact persist. Overall the decision tree classifier does a good job and shows tie persis- tence in social networks is fairly predictable in the short-term from local structural, temporal and vertex-level information. The last two columns of Table 4 present these same fit statis- tics when we use the logistic regression classifier for the de- cay/persistence prediction task. The results are very similar to the results obtained when using the C4.5 decision tree model. The logistic regression correctly predicts 73.4% of all ties (ac- curacy), and for the majority class about 72% of persisting ties are correctly classified by the regression model (recall). In con- trast to the decision tree model, the recall values are higher for the decay class. The logistic regression model correctly classi- fies about 75% of decayed ties, while the decision tree model correctly classifies about 71.4% of decayed ties. This is not a big difference, but it does seem to indicate that in this case the logistic regression model does a slightly better job predicting decay, while the decision tree model does a slightly better job predicting persistence. However, the precision results on the decay class are slightly worse in the logistic regression model compared to the decision tree model. The result is that the F- statistic is about the same across the two models. Tree Logistic Persist Decay Persists Decay Accuracy Precision Recall F 0.737 0.780 0.754 0.767 0.737 0.684 0.714 0.699 0.734 0.796 0.722 0.757 0.734 0.668 0.751 0.707 Table 4: Comparison of model fit-statistics for the decision-tree and logistic regression classifiers. In sum, both the decision tree and logistic regression clas- sifiers indicate that tie persistence and decay patterns are pre- dictable and that using either model yields fairly similar lev- els of prediction and error. The consistency between these two ways of modeling the data -- a more standard regression ap- proach and a relatively non-standard data mining approach -- gives us confidence in the results. After presenting the results of the logistic regression coefficients in the next section, we turn to the decision tree results and show how they yield new insights about what is predicting tie persistence/decay in social networks. 10.2. Logistic regression classifier results Table 5 shows the parameter estimates from the logistic re- gression model (predicting the log-odds of a tie persisting) along with the odds-ratios. The estimates are based on a full model including all the features. We do not report standard errors as all the estimates are statistically significant given the large size of the training data on which these parameters are estimated. Beginning with the features that our information gain values indicated were likely to be the most important (see table 3 and the discussion in section 9) we see that the call volume from ito j (directed tie strength, ci j) has a positive effect on persistence. For each additional call made, the odds of the tie persisting is almost 4% higher. Net of this influence, the number of calls that j makes back to i, c ji, is also positive. For each additional reciprocating call, the odds of a tie persisting increases about 2%. The effects of the outdegree of each member of the dyad have opposite signs. In general, an edge that starts from a vertex with a large number of neighbors has a higher chance of decaying. However, if that edge is directed at a vertex of high-degree, then it has higher chances of persisting. These effects have a straight- forward interpretation, high-degree actors have less persistent edges, but this effect is mitigated when these edges are directed towards other high-degree actors.4 The other two vertex-level features pertaining to gregariousness (ci and c j) have very small effects. This indicates that after adjusting for degree, raw com- municative activity does not appear to be involved in processes of edge persistence and decay. Turning to the neighborhood-level measures, all the effects are positive except for the 2nd order embeddedness measure in jn, which as noted earlier is correlated with di and d j. In gen- eral embeddedness increases the odds that a tie will persist, con- sistent with previous research that show that embedded edges decay at a slower rate (Burt, 1997, 2000). For each additional common neighbor between i and j, the odds of a tie persisting increases 5.4%. The directed embeddedness measures in and jn appear to be even stronger. For example, for each additional neighbor of i that calls j the odds of the tie persisting increases 15%. Finally the temporal measures have opposite effects. f date has a negative effect on persistence indicating the newer ties 4This suggests that bulk of the fluctuating, low-persistence edges character- istic of high-degree actors are those which are directed towards actors of low degree. When popular actors connect to other popular actors, their relationships tend to be more stable than when they connect to low-degree alters. Conversely, while low-degree actors tend to have -- on average -- -more stable relationships, these become even more stable when directed at more popular alters. 16 Feature Description β Odds (exp(β)) di d j ci c j ci j c ji pi j p ji in jn cn jnin in jn f date edate Degree of i Degree of j Calls made by i Calls made by j Calls from i to j Calls from j to i Proportion of i's calls that go to j Proportion of j's calls that go to i Number of i's neighbors that call j. Number of j's neighbors that call i's neighbors. Number of common neighbors between i and j. Number of j's neighbors that call i's neighbors. Number of i's neighbors that call j's neighbors. Time of first call from i to j. Time of last call from i to j. -0.0335 0.0057 0.0003 -0.0013 0.0373 0.0229 0.0504 0.8521 0.1409 0.0877 0.0525 -0.0366 0.0416 -2.3021 2.9218 0.9671 1.0057 1.0003 0.9987 1.0380 1.0232 1.05178 2.3446 1.1513 1.0917 1.05391 0.9641 1.0425 0.1000 18.5747 Table 5: Logistic regression coefficients of the effect of each feature in predicting edge-persistence. (which have higher values on f date) are more likely to decay, indicative of the liability of newness that Burt (1997) notes is an important characteristics of social ties. On the other hand edate, the freshness of the tie, has a positive effect on persistence. Ties that have been activated recently are more likely to persist than those that have been inactive. 10.3. Decision-tree classifier results As we mentioned in Section 6.1, the structure of decision trees can offer insights into the underlying characteristics of the data on which they were trained. Recall that, at each subtree, our C4.5 implementation chooses the attribute with the largest information gain on the data within that subtree. This means that, at each step, the attribute providing the greatest amount of additional information is chosen for further splitting. Fig- ure 5 shows selected branches of the resulting decision-tree obtained from the training data. In the figure, directed edge weight (ci j) -- as measured by the number of calls directed from one person to another -- is the strongest discriminator of class membership as we saw earlier (Table 3) and thus stands as the top node of the tree. As deeper levels of the tree we find that conditional on directed edge weight other dyadic and one tem- poral feature helps to predict tie decay, but not vertex-level fac- tors such as degree and neighborhood level factors such as the number of common neighbors. The left-hand side of the figure shows that the optimal di- rected edge-weight (ci j) cutoff differentiating persistent from decayed dyads in our data is approximately 3. Dyads in which one of the actors contacted the other more than three times in the initial 4-week period have very strong odds of being clas- sified as active in the following 4-week period (p = 0.86). If in addition to that (as we follow the tree into the third level), the edge has been activated recently (has high freshness) then we can be virtually certain that they tie will persist (p = .91). If the edge has not been refreshed recently, however, then the probability of persistence drops substantially (p = .67) The right hand side of the figure shows that for edges with relatively weak directed weight, the odds of decay are relatively high (p = 0.59). If in addition, the edge is non-reciprocal (with 17 Figure 5: Selected leaves of the best-fitting decision-tree obtained from the training set. incoming directed strength being even weaker or equal to zero) then the probability of decay rises concomitantly (p = 0.67). However, even with low levels of directed strength (ci j ≤ 3), an edge characterized by reciprocity has a relatively decent chance of persisting in the next period (p = 0.57), if in addition to this the edge is on the "high-side" of the corresponding weight cut- off (2 ≥ ci j ≤ 3), and it was also active later in the time period (has high-freshness), then the probability then the probability of being classified in the persistent class improve substantially (p = 0.71). 11. Discussion and Conclusion In this paper we explore the question of short-term decay of cell-phone contacts as a problem of decay/persistence predic- tion: determining what local structural features allow us to best determine whether certain dyads that are considered to be con- nected during a given time window will be disconnected dur- ing an immediately adjacent time window. Using large-scale data on millions of dyads from a large non-U.S. cell phone provider, we investigate to what extent we can gain empirical leverage on the decay prediction problem. Our analytic frame- work is guided by prior literature on the structural and vertex- 18 level predictors of edge-decay in informal social networks. Us- ing observational data from call logs, we calculate features of ego-network range, communicative range, edge-strength, reci- procity, embeddedness, edge-newness and edge-freshness. In all we took into account a total of 15 vertex-level, dyadic, neighborhood-level and temporal features (e.g., edge weight, embeddedness, ego-network range, and newness) most of which incorporated information on the relative frequency of interaction, and thus on the weight associated with each com- ponent arc in the cell-phone network (Barrat et al., 2004). The results support our emphasis on the importance of edge weights, as we find that, according to the information gain metric (an information-theoretic measure of predictiveness) factors related to directed edge weight -- essentially the measure of total di- rected communicative flow within the dyad -- are more predic- tive of decay than any of the other types of factors. Our analysis of the correlation structure of the other types of features (vertex, dyad, neighborhood-level and temporal) with empirical indica- tors of edge weight suggested that while there is a reasonable amount of correlation between edge weight and these other fea- tures, it is not strong enough to conclude that edge weight is a redundant by-product of other local-structural factors. To ex- plore the conjoined effect of the various features on edge-decay we built a decision-tree and logistic regression classifier and evaluated their joint effectiveness at predicting short term de- cay in the cell-phone contact network. We found that that both classifiers performs reasonably well. The logistic regression classifier results are consistent with what we know about the structural and temporal dynamics of relationship persistence and decay. Stronger ties are more likely to persist and reciprocation increases persistence as well. While the overall calling activity of each of the actors involved in the dyad is not that important, the number of neighbors that they are connected to is, with decay increasing for outgoing ties origi- nating from high-degree actors, but with this effect being con- tingent on the number of neighbors of the target actor. This result implies that relative inequalities in network range can tell us something about the expected stability of edges in social net- works, as the bulk of the "instability" in edge evolution may be accounted for by the activity of high-degree actors. This re- sult is consistent to that obtained in a network constructed us- ing email trace logs (Aral and Van Alstyne, 2007; Kossinets and Watts, 2006). Embeddedness is also important. When a tie is embeddded in triadic or larger structures, they are pro- tected from fast decay. Finally, new ties are more likely to de- cay, while ties that have been active recently are more likely to persist. Finally, we show that the structure of the decision-tree clas- sifier can provide useful insights on the relative importance of different vertex-level and dyadic level processes in determining the probability that particular types of edges in the cellphone network (e.g. high versus low weight) will decay. The results of the decision-tree classifier are consistent with the initial fea- ture predictiveness results, giving us what combinations of the high-information gain features shown in Table 3 generate per- sistence and decay. As the decision tree shows, the most im- portant predictors are directed edge strength, reciprocated edge strength and the freshness of the tie. So while network range, embeddedness, and tie age can be used to predict persistence as the logistic regression estimates and information gain statistics indicate, they are not the most important factors. Phrased in terms of "rules," we can say that persistent edges in the cell-phone network are those characterized by high-levels of interaction frequency coupled with relatively constant re- activations (freshness) of the edge over time. Edges at high risk of decay on the other hand, are characterized by relatively low levels of interaction and nonreciprocity. Finally, a second path towards persistence appears to be characteristic of "nascent" edges which have yet not had the opportunity to gain strength: here relatively weak flows are combined with reciprocity and recent activation to produce persistence in calling behavior, at least in the short term. In terms of contemporary models of relationship evolution, this last result suggests that in order to persist, social relation- ships must first cross a boundary where the the directed attach- ment between ego and alter becomes "synchronized." This im- 19 plies that the observed strength of older relationships may be an outcome of the achievement of reciprocity at the early stages; thus as Friedkin (1990, 241) notes ". . . reciprocation and bal- ance are crucial for both the occurrence and durability of a strong relationship." In this respect, while strong weight -- and thus frequency of interaction (Homans, 1950) -- is sufficient to guarantee a persistent (if in some cases asymmetric), relation- ship after a certain relationship-age threshold is crossed, reci- procity appears to be more important for the longer-term sur- vival of weaker edges, especially in the nascent stages of the relationship (Friedkin, 1990). These time-dependent balance/strength dynamics therefore seems to us to deserve detailed consideration in future model- ing efforts. In this paper we have attempted establish the begin- nings of a framework with which to rank factors that differen- tiate those links fated for quick dissolution from those that will become a more permanent component of the social structure. References References Aral, S., Van Alstyne, M., 2007. Network structure & information advantage. In: Proceedings of the Academy of Management Conference, Philadelphia, PA. Barrat, A., Barthelemy, M., Pastor-Satorras, R., Vespignani, A., 2004. The architecture of complex weighted networks. Proceedings of the National Academy of Sciences 101 (11), 3747 -- 3752. Bernard, H. R., Killworth, P., Kronenfeld, D., Sailer, L., 1984. The problem of informant accuracy: The validity of retrospective data. Annual Review of Anthropology 13 (1), 495 -- 517. Bidart, C., Degenne, A., 2005. Introduction: the dynamics of personal net- Burt, R. S., 2000. Decay functions. Social Networks 22, 1 -- 28. Burt, R. S., 2002. Bridge decay. Social Networks 24, 333 -- 363. Butts, C. T., 2001. The complexity of social networks: theoretical and empirical findings. Social Networks 23 (1), 31 -- 72. Chakrabarti, D., Faloutsos, C., 2006. Graph mining: Laws, generators, and algorithms. ACM Computing Surveys (CSUR) 38 (1). Clauset, A., Moore, C., Newman, M., 2008. Hierarchical structure and the pre- diction of missing links in networks. Nature 453 (7191), 98 -- 101. Davis, J. A., 1963. Structural balance, mechanical solidarity, and interpersonal relations. American Journal of Sociology 68, 444 -- 462. Davis, J. A., May 1967. Clustering and structural balance in graphs. Human Relations 20 (2), 181 -- 187. URL http://hum.sagepub.com Eagle, N., Pentland, A., Lazer, D., 2009. Inferring friendship network struc- ture by using mobile phone data. Proceedings of the National Academy of Sciences 106 (36), 15274. Eagle, N., Pentland, A., Lazer, D., Cambridge, M., 2008. Mobile phone data for inferring social network structure. Social Computing, Behavioral Modeling, and Prediction, 79 -- 88. Emerson, R., 1972. Exchange theory, part ii: Exchange relations and networks. In: Sociological theories in progress. Vol. 2. Houghton Mifflin, pp. 58 -- 87. Feld, S., Carter, W., 2002. Detecting measurement bias in respondent reports of personal networks. Social Networks 24 (4), 365 -- 383. Feld, S., Suitor, J., Hoegh, J., 2007. Describing changes in personal networks over time. Field Methods 19 (2), 218 -- 236. Freeman, L., Romney, A., Freeman, S., 1987. Cognitive structure and informant accuracy. American Anthropologist, 310 -- 325. Friedkin, N. E., 1990. A guttman scale for the strength of an interpersonal tie. Social Networks 12 (3), 239 -- 252. Getoor, L., Diehl, C., 2005. Link mining: a survey. ACM SIGKDD Explo- rations Newsletter 7 (2), 3 -- 12. Gilula, Z., Haberman, S., 2001. Analysis of Categorical Response Profiles By Informative Summaries. Sociological Methodology 31 (1), 129 -- 187. Granovetter, M. S., 1973. The strength of weak ties. American Journal of Soci- ology 78 (6), 1360 -- 1380. Hallinan, M., Hutchins, E., 1980. Structural effects on dyadic change. Social works. Social Networks 27, 283 -- 287. Forces 59 (1), 225 -- 245. Bidart, C., Lavenu, D., 2005. Evolutions of personal networks and life events. Hallinan, M., Williams, R., 1987. The stability of students' interracial friend- Social Networks 27, 359 -- 376. Bilgic, M., Namata, G., Getoor, L., 2007. Combining collective classification and link prediction. In: Seventh IEEE International Conference on Data Mining Workshops, 2007. ICDM Workshops 2007. pp. 381 -- 386. Brewer, D., 2000. Forgetting in the recall-based elicitation of personal and so- cial networks. Social Networks 22 (1), 29 -- 43. Brewer, D., Webster, C., 2000. Forgetting of friends and its effects on measuring friendship networks. Social Networks 21 (4), 361 -- 373. Burt, R. S., 1997. A note on social capital and network content. Social Networks 19 (4), 355 -- 373. ships. American Sociological Review 52 (5), 653 -- 664. Hallinan, M. T., 1978. The process of friendship formation. Social Networks 1, 193 -- 210. Hammer, M., 1985. Implications of behavioral and cognitive reciprocity in so- cial network data. Social Networks 7, 189201. Hasan, M., Chaoji, V., Salem, S., Zaki, M., 2005. Link prediction using super- vised learning. In: Workshop on Link Discovery: Issues, Approaches and Applications (LinkKDD-2005). Hays, R., 1984. The development and maintenance of friendship. Journal of Social and Personal Relationships 1 (1), 75. 20 Heider, F., 1958. The Psychology of Interpersonal Relations. Wiley, New York. Hidalgo, C., Rodriguez-Sickert, C., 2008. The dynamics of a mobile phone network. Physica A: Statistical Mechanics and its Applications 387 (12), 3017 -- 3024. ences of the United States of America 104 (18), 7332 -- 7336, *. URL internal-pdf://Structureandtiestrengthsinmobilecommunicationnetworks-3449351936/ Structureandtiestrengthsinmobilecommunicationnetworks. pdf Holland, P. W., Leinhard, S., 1973. Structural implications of measurement er- Opsahl, T., Panzarasa, P., 2009. Clustering in weighted networks. Social net- ror in sociometryy. Journal of Mathematical Sociolog, 85111. works 31 (2), 155 -- 163. Homans, G. C., 1950. The Human Group. Harcourt Brace, New York. Kashima, H., Abe, N., 2006. A parameterized probabilistic model of network evolution for supervised link prediction. In: Proc. of the 2006 IEEE Interna- tional Conference on Data Mining (ICDM 2006). Popescul, A., Ungar, L., 2003. Statistical relational learning for link prediction. In: IJCAI workshop on learning statistical models from relational data. Quinlan, J., 1993. C4. 5: programs for machine learning. Morgan Kaufmann. Snijders, T., 2005. Models for longitudinal network data. In: Models and meth- Kossinets, G., 2006. Effects of missing data in social networks. Social networks ods in social network analysis. Cambridge University Press, pp. 215 -- 247. 28 (3), 247 -- 268. Kossinets, G., Watts, D., 2006. Empirical analysis of an evolving social net- work. Science 311 (5757), 88 -- 90. Krackhardt, D., 1987. Cognitive social structures. Social Networks 9 (2), 109 -- 134. Laumann, E., Marsden, P., Prensky, D., 1989. The boundary specification prob- lem in network analysis. In: Freeman, L. C., White, D. R., Romney, A. K. (Eds.), Research methods in social network analysis. University Publishing Associates, Lanham, MD, pp. 61 -- 87. Leskovec, J., Backstrom, L., Kumar, R., Tomkins, A., 2008. Microscopic evolu- tion of social networks. In: 14th ACM SIGKDD Conference on Knowledge Discovering and Data Mining (KDD'08). ACM New York, NY, USA. Snijders, T., Van de Bunt, G., Steglich, C., 2010. Introduction to stochastic actor-based models for network dynamics. Social Networks 32 (1), 44 -- 60. Suitor, J., Keeton, S., 1997. Once a friend, always a friend? effects of ho- mophily on women's support networks across a decade. Social Networks 19, 51 -- 62. Suitor, J., Wellman, B., Morgan, D., 1997. It's about time: How, why, and when networks change. Social Networks 19 (1), 1 -- 7. Tantipathananandh, C., Berger-Wolf, T., Kempe, D., 2007. A framework for community identification in dynamic social networks. In: Conference on Knowledge Discovery in Data: Proceedings of the 13 th ACM SIGKDD international conference on Knowledge discovery and data mining. Tuma, N. B., Hallinan, M. T., 1978. The effects of sex, race and achievement Leydesdorff, L., 1991. The static and dynamic analysis of network data using on schoolchildren's friendships. Social Forces 57 (4), 1265 -- 85. information theory. Social networks 13 (4), 301 -- 345. Liben-Nowell, D., Kleinberg, J., 2007. The link-prediction problem for so- cial networks. Journal of the American Society for Information Science and Technology 58 (7). Marin, A., 2004. Are respondents more likely to list alters with certain char- acteristics? implications for name generator data. Social Networks 26 (4), 289 -- 307. Marmaros, D., Sacerdote, B., 2006. How do friendships form?*. Quarterly Journal of Economics 121 (1), 79 -- 119. van de Bunt, G. G., van Duijn, M. A. J., Snijders, T. A. B., 1999. Friendship net- works through time: An Actor-Oriented dynamic statistical network model. Computational & Mathematical Organization Theory 5, 167 -- 192. van Duijn, M. J. A., Zeggelink, E. P. H., Huisman, M., Stokman, F. N., Wasseur, F. W., 2003. Evolution of sociology freshmen into a friendship network. Journal Of Mathematical Sociology 27, 153 -- 191. Wellman, B., Wong, R. Y., Tindall, D., Nazer, N., 1997. A decade of network change: Turnover, persistence and stability in personal communities. Social Networks 19, 27 -- 50. Marsden, P., Campbell, K., 1984. Measuring tie strength. Social Forces 63, Witten, I., Frank, E., 2005. Data Mining: Practical machine learning tools and 482 -- 501. techniques. San Fransisco, Morgan Kaufman Publishers. Marsili, M., Vega-Redondo, F., Slanina, F., 2004. The rise and fall of a net- worked society: A formal model. Proceedings of the National Academy of Sciences 101 (6), 1439 -- 1442. Menard, S., 2004. Six approaches to calculating standardized logistic regression coefficients. The American Statistician 58 (3), 218 -- 223. O'Madadhain, J., Hutchins, J., Smyth, P., 2005. Prediction and ranking algo- rithms for event-based network data. ACM SIGKDD Explorations Newslet- ter 7 (2), 23 -- 30. OMadadhain, J., Smyth, P., Adamic, L., 2005. Learning predictive models for link formation. In: International Sunbelt Social Network Conference. Onnela, J. P., Saramaki, J., Hyvonen, J., Szab´o, G., Lazer, D., Kaski, K., Kert´esz, J., Barab´asi, A. L., 2007. Structure and tie strengths in mobile communication networks. Proceedings of the National Academy of Sci- 21
1202.2928
4
1202
2012-11-26T20:53:36
The Diffusion of Networking Technologies
[ "cs.SI", "cs.DS", "cs.NI", "physics.soc-ph" ]
There has been significant interest in the networking community on the impact of cascade effects on the diffusion of networking technology upgrades in the Internet. Thinking of the global Internet as a graph, where each node represents an economically-motivated Internet Service Provider (ISP), a key problem is to determine the smallest set of nodes that can trigger a cascade that causes every other node in the graph to adopt the protocol. We design the first approximation algorithm with a provable performance guarantee for this problem, in a model that captures the following key issue: a node's decision to upgrade should be influenced by the decisions of the remote nodes it wishes to communicate with. Given an internetwork G(V,E) and threshold function \theta, we assume that node $u$ activates (upgrades to the new technology) when it is adjacent to a connected component of active nodes in G of size exceeding node $u$'s threshold \theta(u). Our objective is to choose the smallest set of nodes that can cause the rest of the graph to activate. Our main contribution is an approximation algorithm based on linear programming, which we complement with computational hardness results and a near-optimum integrality gap. Our algorithm, which does not rely on submodular optimization techniques, also highlights the substantial algorithmic difference between our problem and similar questions studied in the context of social networks.
cs.SI
cs
The Diffusion of Networking Technologies Sharon Goldberg Boston University Zhenming Liu Princeton University [email protected][email protected] † October 29, 2018 Abstract There has been significant interest in the networking community on the impact of cascade effects on the diffusion of networking technology upgrades in the Internet. Thinking of the global Internet as a graph, where each node represents an economically-motivated Internet Service Provider (ISP), a key problem is to determine the smallest set of nodes that can trigger a cascade that causes every other node in the graph to adopt the protocol. We design the first approximation algorithm with a provable performance guarantee for this problem, in a model that captures the following key issue: a node's decision to upgrade should be influenced by the decisions of the remote nodes it wishes to communicate with. Given an internetwork G(V, E) and threshold function θ, we assume that node u activates (upgrades to the new technology) when it is adjacent to a connected component of active nodes in G of size ex- ceeding node u's threshold θ(u). Our objective is to choose the smallest set of nodes that can cause the rest of the graph to activate. Our main contribution is an approximation algorithm based on linear programming, which we complement with computational hardness results and a near-optimum integral- ity gap. Our algorithm, which does not rely on submodular optimization techniques, also highlights the substantial algorithmic difference between our problem and similar questions studied in the context of social networks. Keywords. Linear programming, approximation algorithms, diffusion processes, networks. Bibliographic note. An extended abstract of this work appeared in SODA'13. This is the full version. 2 1 0 2 v o N 6 2 ] I S . s c [ 4 v 8 2 9 2 . 2 0 2 1 : v i X r a ∗Supported by NSF grant S-1017907 and a gift from Cisco. †Supported by NSF grants CCF-0915922 and IIS-0964473. 0 Contents 1 Introduction 1.1 Our results. . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 2 Linearization & formulating the IP 3 Rounding algorithm. 3.1 Resolving inconsistencies via rejection-sampling . . . . . . . . . . . . 3.2 Strengthened IP and coupled sampling . . . . . . . 3.2.1 The need for stronger constraints 3.2.2 The flow constraints . . . . . . . . . . . . . . . . . . 3.2.3 Why coupled sampling works. . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 2 3 4 5 7 8 8 8 9 12 16 18 19 . . . . . . 19 . . . . . . 21 . . . . . . 21 . . . . . . 22 23 23 . . . . . . 23 . . . . . . 25 . . . . . . 26 . . . . . . 26 . . . . . . 29 . . . . . . 32 34 . . . . . . 34 . . . . . . 34 . . . . . . 35 . . . . . . 36 . . . . . . 36 . . . . . . 37 38 4 Experiments with the IP of Figure 1 A Optimal connected activation sequences provide a 2-approximation B The augmented integer program (proof of Lemma 3.4) C Missing proofs for Section 3 C.1 Proof of Lemma 3.3 (Success of a single trial) . . C.2 Proof of Lemma 3.6 (Border node lemma) . . . . C.3 Proof of Lemma 3.7 . . . . . . . . . . . . . . . C.4 First part of Proposition 3.1 . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . D Proof of Corollary 1.3 E Lower bounds E.1 Computational barrier . . . . E.2 Combinatorial barrier . . . . E.3 Integrality gap . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . E.4 Remark on the role of flow constraints in reducing the integrality gap . . . . . . . . . . . . . . . . . . . . Integrality gap for the simple IP of Figure 1 . . . . . Integrality gap for the augmented IP of Figure 2. . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . E.3.1 E.3.2 . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . F Supplement: Our problem is neither submodular nor supermodular F.1 Fixed threshold case . . . . . F.1.1 The influence function is not submodular. F.1.2 The influence function is not supermodular. . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . F.2 Randomized threshold case . . . . . . F.2.1 The influence function is not submodular. F.2.2 The influence function is not supermodular. . . . . . . G Supplement:Expository examples and figures 1 1 Introduction There has been significant interest in the networking community on the impact of cascade effects on the diffusion of technology upgrades in the Internet [4, 10, 15, 21, 22, 26, 29, 34, 35, 44]. Thinking of the global Internet as a graph, where each node represents an independent, economically-motivated autonomous system (AS), e.g., AT&T, Google, Telecom Italia, or Bank of America, a key problem is to determine the set of nodes that governments and regulatory groups should target as early adopters of the new technology, with the goal of triggering a cascade that causes more and more nodes to voluntarily adopt the new technology [10, 26, 29, 35]. Given the effort and expense required to target ASes as early adopters, a natural objective (that has appeared in both the networking literature [4, 10, 26] and also that of viral marketing [20, 37]) is to find the smallest possible seedset of early adopters that could drive a cascade of adoption; doing this would shed light on how best to manage the upgrade from insecure routing [9] to secure routing [38, 39], or from IPv4 to IPv6 [16], or the deployment of technology upgrades like QoS [32], fault localization [6], and denial of service prevention [50]. Thus far, the literature has offered only heuristic solutions to the problem of the diffusion of networking technologies. In this paper, we design the first approximation algorithm with a provable performance guar- antee that optimizes the selection of early adopter nodes, in a model of that captures the following important property: the technologies we study only allow a pair of nodes to communicate if they have a path between them consisting of nodes that also use the new technology [6, 10, 26, 32, 33, 39, 50]. Model. Consider a graph G(V, E) that represents the internetwork. We use the following progressive process to model the diffusion of a new technology: a node starts out as inactive (using an older version of the technology) and activates (adopts the new, improved technology) once it obtains sufficient utility from the new technology. Once a node is active, it can never become inactive. To model the cost of technology deployment, the standard approach [28, 37, 47] is to associate a threshold θ(u) with each node u that determines how large its utility should be before it is willing to activate. A node's utility depends on the size of the connected components of active nodes adjacent to u in G. Thus, node u activates if the connected component containing u in the subgraph induced in G by nodes {v : v ∈ V, Node v is active} ∪ {u} has size at least θ(u). We study the following optimization problem: Given G and the threshold function θ : V → {2, ..., V }, what is the smallest feasible seedset S ⊆ V such that if nodes in S activate, then all remaining nodes in V eventually activate? This model of node utility captures two key ideas: 1. the traditional notion of "direct network externalities/effects" from economics [23, 36], marketing [7] and other areas [43], that supposes an active node that is part of a network of k active nodes has utility that scales with k, and 2. the fact that we are interested in networking technologies that only allow a pair of active nodes u, v ∈ G(V, E) to communicate if there is path of active nodes between them in G. Our model has much in common with the vast literature on diffusion of innovations, and especially the linear threshold model for diffusion in social networks, articulated by Kempe et al. [37] and extensively studied in many other works. Indeed, the two models diverge only in the choice of the utility function; ours is non-local, while theirs depends the (weighted) sum of a node's active neighbors in G. Meanwhile, the non-local nature of our utility function has much in common with the classic literature on "direct network externalities/effects" [7, 23, 36, 43] with the important difference that these classic models ignore the under- lying graph structure, and instead assume that utility depends on only a count of the active nodes. We shall now see that these differences have a substantial effect on our algorithmic results. 2 1.1 Our results. Our main result is an approximation algorithm based on linear programming that consists of two phases. The first is a linearization phase that exploits combinatorial properties to encode our problem as an integer program (IP) with a 2-approximate solution, while the second is a randomized rounding algorithm that operates by restricting our search space to connected seedsets, i.e., seedsets that induce a connected subgraph of G . We have: Theorem 1.1 (Main result). Consider a networking technology diffusion problem {G(V, E), θ} where the smallest seedset has size opt, the graph has diameter r (i.e., r is the length of "longest shortest path" in G), and there are at most ℓ possible threshold values, i.e., θ : V → {θ1, ..., θℓ}. Then there is a polynomial time algorithm that returns a seedset S of size O(rℓ log V · opt). Relationship to the linear threshold model in social networks. Our main result highlights the major algorithmic difference between our work and the linear threshold model in social networks [37]. In the social network setting, Chen [11] showed that this problem is devastatingly hard, even when r, ℓ = O(1); to avoid this discouraging lower bound, variations of the problem that exploit submodular properties of the objective have been considered (e.g., where thresholds are chosen uniformly at random [37] or see [12, 45] and references therein). Indeed, the ubiquity of these techniques seems to suggest that diffusion problems are tractable only when the objective exhibits submodularity properties. Our work provides an interesting counterpoint: our positive result does not rely on submodular optimization, and we show that the influence function in our problem, and its natural variations, lacks submodularity properties. Dependencies on r, ℓ, and log V are necessary. Removing our algorithm's dependence on r, ℓ, or log V is likely to require a very different set of techniques because of the following barriers: 1. Computational barrier. We use a reduction from Set Cover to show that our problem does not admit any o(ln V )-approximation algorithm, even if r, ℓ = O(1). 2. Combinatorial barrier. We present a family of problem instances that prove that any algorithm that returns a connected seedset must pay an Ω(r)-increase in the size of the seedset in the worst case. 3. Integrality gap. The linear program we use has an integrality gap of Ω(ℓ) so that our rounding algorithm is asymptotically optimal in ℓ. Quality of approximation. We interpret the quality of our approximation for typical problem instances. Networking. The motivation for our problem is to help centralized authority (e.g., a government, a regula- tory group) determine the right set of autonomous systems (ASes) in the Internet to target as early adopters for an upgrade to a new networking technology [24, 42]. We comment on the asymptotic order of r and ℓ when a centralized authority executes this algorithm. The graph G is the Internet's AS-level graph, which is growing over time, with diameter r that does not exceed O(log V ) (see, e.g., [40]). We remark that the empirical data we have about the Internet's AS-level topology [3, 14, 19, 48] is the result of a long line of Internet measurement research [46]. On the other hand, obtaining empirical data on ASes' thresholds is still subject to ongoing research [24, 27]. The following natural assumption and practical constraint restrict the threshold granularity ℓ: (a) ASes should not be sensitive to small changes in utility (e.g., 1000 nodes vs. 1001 nodes), and that (b) in practice, it is infeasible for a centralized authority to obtain information about θ(u) from every AS u in the Internet, both because this business information is kept private and be- cause, perhaps more importantly, many of these nodes are in distant and possibly uncooperative countries. Thus, thresholds should be chosen from a geometric progression {(1 + ǫ), (1 + ǫ)2, ...., (1 + ǫ)ℓ} or even restricted to a constant size set {5%, 10%, 15%, 20%, 30%, 50%} as in [10, 26, 44] so that ℓ = O(log V ). Our approximation ratio is therefore polylogarithmic in V in this context. 3 Other settings. Since our model is a general, there could be other settings where ℓ may not be O(log V ). Here, the performance of our algorithms is governed by the stability of the problem instance. Stability refers to the magnitude of the change in the optimal objective value due to a perturbation of the problem instance, and is commonly quantified using condition numbers (as in e.g., numerical analysis and optimization [17, 31, 41]). We naturally expect unstable problem instances (i.e., with large κ) to be more difficult to solve. Indeed, we can use condition numbers to parameterize our approximation ratio: Definition 1.2 (Condition number). Consider a problem instance Π = {G, θ} and a positive constant ǫ. Let Π+ = {G, θ+} and Π− = {G, θ−} be two problem instances on the same graph G where for every v ∈ V , we have θ+(v) = (1 + ǫ)θ(v) and θ−(v) = (1 − ǫ)θ(v). Let opt+ (opt−) be the value of the optimal solution for Π+ (Π−). The condition number is κ(Π, ǫ) , opt+ opt− . Corollary 1.3. Let ǫ be an arbitrary small constant. There exists an efficient algorithm to solve a technology diffusion problem Π = {G, θ} whose approximation ratio is O(κ(Π, ǫ) · r). See details in Appendix D. Finally, we remark that our IP formulation might also be a promising starting point for the design of new heuristics. Indeed, in Appendix 4 we ran a generic IP solver to find seedsets on problem instances of non-trivial size; the seedsets we found were often substantially better than those returned by several natural heuristics (including those used in [4, 10, 26]). Organization. We present our IP formulation in Section 2, and describe our rounding algorithm in Sec- tion 3. All missing proofs are in Appendix A-D. Lower bounds are in Appendix E. We also present supple- mentary material on the (lack of) submodularity/supermodularity properties of our problem (Appendix F), our experimental results (Appendix 4), and expository examples and figures (Appendix G). 2 Linearization & formulating the IP In this section we show how to sidestep any potential difficulties that could result from the non-local nature of our setting. To do this, we restrict our problem in a manner that allows for easy encoding using only linear constraints, while still providing a 2-approximation to our objective. We need the following notions: Activation sequences. Given a seedset S, we can define an activation sequence T as a permutation from V to {1, ..., n} where n = V that indicates the order in which nodes activate. The t-th position in the sequence is referred as the t-th timestep. We allow a seed node to activate at any timestep, while a non-seed node u may activate at a timestep T (u) as long as u is part of a connected component of size at least θ(u) in the subgraph of G induced by {u} ∪ {v : T (v) < T (u)}. Connected activation sequences. A connected activation sequence T is an activation sequence such that at every timestep t, the set of active nodes induces a connected subgraph of G. We may think of T as a spanning tree over the nodes in the graph, where, at every timestep, we add a new node u to the tree subject to the constraint that u has a neighbor that is already part of the tree. Our IP will find the smallest seedset S that can induce a connected activation sequence. At first glance this could result in a factor of r growth in the seedset size. However, the following lemma, which may be of independent interest, shows that the seedset size grows at a much smaller rate: Lemma 2.1. The smallest seedset that can induce a connected activation sequence is at most twice the size of the optimal seedset. 4 Sketch of proof of Lemma 2.1. (The full proof is in Appendix A.) We prove that any activation sequence T ∗ induced by the optimal seedset opt can be rearranged to form a connected activation sequence T if we add at most opt extra nodes to the seedset. To see how, consider a timestep in T ∗ when two or more connected active components merge into a single component, and notice that whenever this happens, there is exactly one connector node that activates and joins these two components. In the full proof we show that by adding every connector to the seedset, we can rearrange T ∗ to obtain a connected activation sequence. It remains to bound the number of connectors. Since every connector node decreases the number of disjoint connected components, and each component must contain at least one seed, then there is at most one connector for each seed node, and the 2-approximation follows. min subject to: ∀t, i : ∀i : ∀t : xi,t ∈ {0, 1} Pi≤nPt<θ(vi) xi,t Pt≤n xi,t = 1 Pi≤n xi,t = 1 ∀t > 1, i : P{vi,vi′ }∈E Pt′<t xi′,t′ ≥ xi,t (permutation constraints) (permutation constraints) (connectivity constraints) Figure 1: Simple IP for the networking technology diffusion problem. IP encoding. The beauty of a connected activation sequence T is that every nonseed node's decision to activate becomes local, rather than global: node v need only check if (a) at least one of its neighbors are active, and (b) the current timestep t satisfies t ≥ θ(v). Moreover, given a connected activation sequence T , we can uniquely recover the smallest feasible seedset S that could induce T by deciding that node u is a seed iff θ(v) > T (v). Thus, our IP encodes a connected activation sequence T , as a proxy for the seedset S. Let {v1, v2, ..., vn} be the set of nodes in the network. Let xi,t be an indicator variable such that xi,t = 1 if and only if T (vi) = t. The integer program is presented in Figure 1. The permutation constraints guarantee that the variables xi,t represent a permutation. The connectivity constraints ensure that if xi,t = 1 (i.e., node vi activates at step t), there is some other node vi′ such that vi′ (a) is a neighbor of node vi and and (b) activates at earlier time t′ < t. Finally, the objective function minimizes the size of the seedset by counting the number of xi,t = 1 such that t < θ(vi). We remark that our IP formulation suggests a similarity between our setting and the vehicle routing with time windows problem ( e.g., [5,8,18,25]). Consider a time-windows problem, where we are given an undirected metric graph G and time window [r(u), d(u)] for each node u, and our objective is to choose a tour for the vehicle through G that visits as many nodes as possible during their respective time windows. In our setting (restricted to connected activation sequences), the tour becomes a spanning tree, and each node u has time window [θ(u), n]. Understanding the deeper connection here is an interesting open question. 3 Rounding algorithm. Unfortunately, the simple IP of Figure 1 has a devastating Ω(n) integrality gap (Appendix E.3.1). We eliminate this integrality gap by adding extra constraints to the IP of Figure 1, and refer to the resulting IP as the augmented IP. We defer presentation of this IP to Section 3.2.2 and focus now on the high level structure of our rounding algorithm. Our rounding algorithm is designed to exploit the relationship between seedset S and connected acti- vation sequences T ; namely, the fact that we can uniquely recover a S from T by deciding that node u is a seed if T (u) < θ(u). As such, it returns both S and T with the following four properties: 5 1. Consistency. S and T are consistent; namely, T is an activation sequence for the diffusion process induced by {G, θ, S}. (Recall that T is such that any seed u ∈ S can activate at any time, and any non-seed u /∈ S can activate whenever it is connected to an active component of size at least θ(u)−1.) 2. Feasibility. T is such that every node eventually activates. 3. Connectivity. T is a connected activation sequence. 4. Small seedset. The seedset S has "small" size, i.e., bounded in the size of the objective function of the solution to our LP. But how should we round the fractional xi,t values returned our LP relaxation to achieve this? Let's first consider two natural approaches for sampling S and T : Approach 1: Sample the seedset S: Recall that in a connected activation sequence, a node that activates at time t < θ(u) must be a seed. Therefore, we can sample the seedset S by adding each node vi to S with Approach 2: Sample the activation sequence T : We can instead sample the activation sequence T by probability proportional to Pt<θ(vi) xi,t. deciding that node vi activates before time t with probability proportional to Pτ <t xi,τ . However, neither of these approaches will work very well. While Approach 1 guarantees that the seedset S is small (Property 4), it completely ignores the more fine-grained information provided by the xi,t for t ≥ θ(vi) and so its not clear that nonseed nodes will activate at the right time (Property 2). Meanwhile, Approach 2 guarantees feasibility (Property 2), but by sampling activation times for each node independently, it ignores correlations between the xi,t. It is therefore unlikely that the resulting T is connected (Property 3), and we can no longer extract a small seedset (Property 4) by checking if T (u) < θ(u). Instead, we design a sampling procedure that gives us a coupled pair {S, T } where, with high proba- bility, (a) the distribution of S will be similar to that of Approach 1, so that the seedset is small (Property 4), while (b) the distribution of T will be similar to Approach 2, so we have feasibility (Property 2), and also (c) that T is connected (Property 3). However, S and T are not necessarily consistent (Property 1). Later, we show how we use repeated applications of the sampling approach below to correct inconsistencies, but for now, we start by presenting the sampling routine: Approach 3: Coupled sampling. We start as in Approach 1, adding each v ∈ V to S with proba- bility minn1, αPt<θ(v) xv,to, where α is a bias parameter to be determined. We next run deterministic processes: S ← GLUE(S) followed by T ← GETSEQ(S). The GLUE procedure, defined below, ensures that S is connected (i.e., induces a connected subgraph of G), and blows up S by an O(r)-factor (where r is graph diameter). Meanwhile, GET-SEQ, defined in Section 3.2.3, returns a connected activation sequence T ; we remark that T may not be a permutation (many nodes or none could activate in a single timestep), and may not be feasible, i.e., activate every node. GLUE(S) 1 while S is not connected 2 3 4 5 return S. do Let C be the largest connected component in the subgraph induced by S. Pick u ∈ S \ C. Let P be the shortest path connecting u and C in G. Add nodes in P to S. The properties of Approach 3 are captured formally by the following proposition, whose proof (Sec- tion 3.2) presents a major technical contribution of our work: 6 Proposition 3.1. Let α = 24(1 + ǫ) ln( 4n2 ǫ ) and ǫ be a suitable constant. Then there exists an augmented IP and an efficiently computable function GET-SEQ(·) such that Approach 3 returns S and T (that are not necessarily consistent), where 1. T is connected, 2. for any v /∈ S we have that T (v) ≥ θ(v), and 3. for any v and t, • if Pt′≤t xv,t′ ≥ 1 • if Pt′≤t xv,t′ < 1 12(1+ǫ) , then Pr[T (v) ≤ t] ≥ 1 − ǫ 12(1+ǫ) , then Pr[T (v) ≤ t] ≥ (1 + ǫ)(Pt′≤t xv,t′ ). 4n2 . are right at the transition point (i.e., Pt′≤t xv,t′ = Notice that the third item in Proposition 3.1 suggests that the distribution of T in Approach 3 is "close" to that of Approach 2. We also remark that in this item the parameters are not optimized. Thus when we 12(1+ǫ) ), the two cases give quite different bounds. In the subsequent section, we apply the ideas we developed thus far to design an algorithm that uses Proposi- tion 3.1 to "error-correct" inconsistencies between S and T so that all four properties are satisfied. Then, in Section 3.2 we present the more technically-involved proof of Proposition 3.1. 3.1 Resolving inconsistencies via rejection-sampling 1 Recall the threshold function θ : V → {θ1, ..., θℓ}, and suppose a threshold θj is good with respect to T if there are at least θj − 1 active nodes in T by time θj − 1. The following simple lemma presents the properties we need from our rejection sampling algorithm: Lemma 3.2. Let S be a seedset and T be an activation sequence. If: • (P1). T is connected and feasible (for any v ∈ V , T (v) ≤ n), and • (P2). T (v) ≥ θ(v) for all v /∈ S, and • (P3). Every θj for j ∈ [ℓ] is good with respect to T (·), then S is consistent with T and S is a feasible seedset. Proof. To show that S and T are consistent, we argue that by the time a non-seed v /∈ S activates in T , there are at least θ(v) − 1 active nodes. Since v activates at time T (v) ≥ θ(v), this follows because T (·) is connected and each θj is good. Since T is feasible and S is consistent with T , we have that S is feasible. We construct a pair of {S, T } that meets the properties of Lemma 3.2 in two phases. First, we construct ℓ pairs {S1, T1}, ..., {Sℓ, Tℓ} where for each {Sj, Tj} we have that (P.1) and (P.2) hold, a single threshold θi is good w.r.t. Ti, and Si is "small", i.e., Si ≤ 24(1 + ǫ)2 ln( 4n2 ǫ )r · opt. The second phase assembles these ℓ pairs into a single {S, T } pair so all θj are good w.r.t. T , so that (P1)-(P3) hold, and the seedset S is bounded by O(rℓ ln n · opt), so our main result follows. Step 1. Rejection-sampling to find {Sj, Tj} pairs ∀j ∈ [ℓ]. Thus, while we sample Tj that may not be permutations, the following lemma (proved in Appendix C.1) shows that we can repeat Approach 3 until we find Sj, Tj that satisfy the required properties: Lemma 3.3 (Success of a single trial). Let Sj and Tj be sampled as in Approach 3. For any t, let At be the number of nodes active in Tj up to time t (inclusive). Then Pr[At ≥ t ∧ An = n] ≥ ǫ 2n . To see why, observe that (P1)-(P2) hold by Proposition 3.1, and θj is good w.r.t. Tj with probability ǫ 2n by Lemma 3.3, and Sj has the required size with probability ≥ 1 − 1 n10 by standard Chernoff bounds (the exponent 10 here is chosen arbitrarily). Therefore, we successfully find the required {Sj, Tj} with probability ǫ n10 in a single trial. After O(n log n) independent trials, we find the required {Sj, Tj} with probability 1 − 1/nc for sufficiently large c. 2n − 1 7 Step 2. Combine the {Si, Ti} to obtain the final {S, T }. We can now construct our final {S, T } pair in a rather straightforward way: to construct S, we take the union of all the Sj's and then use GLUE to connect them; that is we take S ← GLUE(Sj≤ℓ Sj). To construct T , we set T (v) = 1 for all seeds v ∈ S and T (v) = minj≤ℓ Tj(v) (∀v ∈ V \S). To conclude, we need show that this {S, T } pair satisfies Lemma 3.2. • First we show (P1) holds. Since every Tj is feasible, and T (v) ≤ Tj(v) by construction, it follows that T is also feasible. Next we show that T (v) is connected by induction over t. As a base case, observe that T = minj≤ℓ Tj(v) is connected at t = 1, since the seedset S = GLUE(Sj Sj) is connected. As the induction step, we assume that T is connected up to time t (inclusive) and show that T is also connected up to time t + 1 (inclusive). To do this, let v be a node such that T (v) = t + 1. It follows that there exists j ≤ ℓ such that Tj(v) = t + 1; since Tj is connected, there must be another node u such that Tj(u) < t + 1 and u and v are neighbors in the graph G. Since T (u) ≤ Tj(u), it follows that v is connected to a node (namely node u) that is active at time t + 1, and the induction step follows. • We show that (P2) holds. For all v /∈ S, we have v /∈ Sj for all j ≤ ℓ. This means Tj(v) ≥ θ(v) for all j. Therefore, T (v) ≥ θ(v) and (P2) holds. • Finally, (P3) holds. For each j ≤ ℓ we know that θj is good w.r.t to Tj. For all j ≤ ℓ, every node v has T (v) ≤ Tj(v) by construction, so that the number of active nodes at time θj in T must be no fewer than the number of active nodes in Tj. (P3) follows since θj is good w.r.t to Tj for every j ≤ ℓ. It follows that Lemma 3.2 holds and the final seedset S is indeed a feasible seedset. Since the size of each seedset Si is bounded by O(r log n · opt) (and the gluing in Phase 2 grows the seedset by an additive factor of at most ℓ · r) it follows that S has size at most O(ℓr log n · opt) and our main result follows. 3.2 Strengthened IP and coupled sampling We show how we use a flow interpretation of our problem to prove Proposition 3.1. 3.2.1 The need for stronger constraints In Appendix E.3.1, we show that the LP in Figure 1 has an Ω(n) integrality gap. To understand why this gap comes about, let us suppose that each xi,t returned by the LP is a mass that gives a measure of the probability that node vi activates at time t. Consider the following example: Pathological example. Consider a graph that contains a clique of nodes A,B and C. Suppose the LP returns a solution such that at t = 1, node A has mass 0.1, while all other nodes have mass 0. The constraints repeat- edly allow mass from node A to circu- late through nodes B and C and then back to A, as shown in the variable as- signments beside. Finally, at t = 9, enough mass has circulated back to A, so that A has mass 0.9 and thus "probability" 0.9 of activating. Note that this is highly artificial, as all of this mass originated at A to begin with! In fact, no matter how we interpret these xi,t, the example suggests that this "recirculation of mass" is unlikely to give us any useful information about when node A should actually activate. 3.2.2 The flow constraints t = 1 xA,1 = 0.1 t = 2 xB,2 = 0.1 (because xB,2 ≤ xA,1) t = 3 xC,3 = 0.1 (because xC,3 ≤ xB,1 t = 4 xB,4 = 0.2 (because xB,4 ≤ xA,1 + xC,3) t = 5 xC,5 = 0.2 (because xC,5 ≤ xB,2 + xB,4) t = 6 xB,6 = 0.4 (because xB,6 ≤ xA,1 + xC,3 + xC,5) t = 7 xC,7 = 0.7 (because xC,7 ≤ xB,2 + xB,4 + xB,6) t = 8 xB,8 = 0.3 (because xB,8 ≤ xA,1 + xC,3 + xC,5 + xC,7) t = 9 xA,9 = 0.9 (because xA,9 ≤ Pt′≤8 xB,t′) Inspired by the example above, we can reduce the size of the integrality gap by thinking of the diffusion process in the context of network flows. Specifically, we suppose that when a nonseed node u activates at 8 time T (u), a unit flow originates at a seed node and flows to node u along the network induced by the nodes active prior to timestep T (u). We therefore augment the IP of Figure 1 with this idea by introducing flow constraints: The flow network. For any solution {xi,t}i,t≤n, we define a flow network H, with vertex set V (H) = {Xi,t : i, t ∈ [n]} and edge set E(H) = {(Xi,t, Xi′,t′) : t′ > t ∧ {vi′, vi} ∈ E(G)}. Every node Xi,t in the flow network H has capacity xi,t, while edges in H do not have capacity bounds. We let the line that connects nodes {Xi,t : t = θ(vi)} be the threshold line. All the Xi,t such that t < θ(vi) are flow graph nodes to the left of the threshold line; very roughly, these nodes corresponds the region where vi is a seed. The rest are flow graph nodes to the right of the threshold line, and roughly correspond to vi being a nonseed. A sample flow graph and its threshold line appears in Appendix G. Flow constraints. For now, we suppose the first node to be activated in the optimal solution is known to be v1 (so that x1,1 = 1); this assumption is removed in Appendix B. For any i and t ≥ θ(vi), we define the (i, t)-flow as the multiple-sink flow problem over the flow network H, where the source is X1,1 and the sinks are nodes to the right of threshold line, namely {Xi,θ(vi), Xi,θ(vi)+1, ..., Xi,t}. The demand for the sink Xi,t is xi,t. Our flow constraints require that every (i, t)-flow problem (for all i and all t ≥ θ(vi)) has a solution. In Appendix B we show that how to implement these flow constraints using the maximum-flow- minimum-cut theorem and a separation oracle. Appendix B presents the implementation of the augmented IP in Figure 2, as well as the proof of the following: Lemma 3.4. The augmented IP for the technology diffusion problem is such that • when T (v1) = 1 in the optimal connected activation sequence, this IP returns the same set of feasible solutions as the simple IP of Figure 1. • the fractional solution for the corresponding relaxed LP satisfies all the (i, t)-flow constraints. Eliminating the integrality gap. The flow constraints eliminate the pathological example above, and therefore also the Ω(n) integrality gap. To see why, notice that the (B, 4)-flow problem has total demand 0.2 (i.e., xB,2 = 0.1 and xB,4 = 0.1) but there is no way to supply this demand from XA,1. 3.2.3 Why coupled sampling works. In addition to improving the robustness of our IP, the flow constraints also have the following pleasant interpretation that we use in the design our rounding algorithm: if there is a flow f ∈ [0, 1] from a seed node to a non-seed node u at time t, then node u has probability f of activating at time t. On connected seedsets. To ensure that all network flows originate at seed nodes, Approach 3 requires GET-SEQ to return an activation sequence T where all seed nodes activate before the non-seed nodes. If we couple this with the requirement that T is connected (so we can use the trick of deciding that node v is a seed if T (v) < θ(v)), it follows that we require a connected seedset S (i.e., the nodes in S induce a connected subgraph of G). Approach 3 achieves this by using GLUE to connect the nodes it samples into its seedset S, and then deterministically generates T using GET-SEQ as specified below, and illustrated in Appendix G. 9 GET-SEQ(H, S) 1 Initialize by flagging each Xu,t ∈ H as "inactive" by setting bu,t ← 0. 2 ∀ u ∈ S, bu,t ← 1 for all t. 3 for t ← 1 to n 4 5 6 7 Obtain T by taking T (u) ← min {t : bu,t = 1} for every u ∈ V . 8 return T . if (∃v, τ : ((Xv,τ , Xi,t) ∈ E(H)) ∧ (bv,τ = 1)) bu,t′ ← 1 for t′ ≥ t do ∀ u s.t. θ(u) ≥ t: // "Activate" all Xu,t for all u in the seedset. // "Activate" each Xu,t′ to the right of timestep t. Intuition behind the proof of Proposition 3.1. Given the probabilistic interpretation of flows, consider what happens if two disjoint flows f1 and f2 originate from different seeds and arrive simultaneously at node u at time t. The total flow at node u at time t is then f1 + f2. What does this merge of two disjoint flows mean in our probabilistic interpretation? It turns out that the natural interpretation is already pretty sensible: with probability f1, the technology is diffused via the first flow, and with probability f2 the technology is diffused via the second flow. Now, the probability that the technology is diffused to u via either of these two flows is 1 − (1 − f1)(1 − f2). When f1, f2 are both small, this probability becomes ≈ f1 + f2, so that the total flow can be used to determine node u's activation probability. On the other hand, when f1 or f2 is large, we are fairly confident that u should activate prior to time t, and so we can simply decide that T (u) ≤ t without incurring a large increase in the size of the seedset. Given that the total demand in the time t is roughly proportional to this demand. Also, notice that u itself is chosen as a seed with probability (u, t) flow problem is Pθ(u)≤τ ≤t xu,τ , it follows that the probability that u is a nonseed and is activated by Pτ <θ(u) xu,τ so by combining these events in the appropriate way, we get that Pr[T (u) ≤ t] ∝ Pτ <t xu,τ as required by the third item in Proposition 3.1. To formalize this intuition, we first describe how GET-SEQ in Figure ?? works (see also Appendix G): Get-Seq. GET-SEQ deterministically constructs the activation function T (·) from a seedset S and flow network H by first activating all seeds u ∈ S at timestep t = 1. GET-SEQ then iterates over each timestep t, and activating every nonseed node u /∈ S where (a) time t is after its threshold, i.e., t ≥ θ(u), and (b) there is an edge in H to Xu,t from some other Xv,t′ such that node v is active at time t′ < t. Observe that the iterative nature of this procedure, along with the structure of H and the fact that the seedset S is connected, implies that there is also a path in H from X1,1 to Xu,t consisting of "active" vertices Xv,τ , i.e., vertices in H such that T (v) ≤ τ . We next introduce a few definitions. First, for each pair u and t (where t ≥ θ(u)), let an arbitrary (but fixed) solution Fu,t for the (u, t)-flow problem be the representative flow for the (u, t)-flow problem. To help us understand how disjoint flows merge, we use the following notion: Definition 3.5 (Border nodes). Consider the (u, t)-flow problem on the flow graph H and the corresponding representative flow Fu,t. Let us decompose the flow into paths (in an arbitrary but consistent manner) P1, P2, ..., Pq. Consider an arbitrary path Pk and let Xj,τ be the last node on Pk that is to the left of the threshold line. Define Xj,τ = border(Pk). • The border nodes for the (u, t)-flow problem on flow graph H are β(u, t) , {border(P1), ..., border(Pq)}. • The border nodes for the (u, t)-flow problem on G are B(u, t) , {vj : ∃τ s.t. Xj,τ ∈ β(u, t)}. For notational convenience, when t < θ(u), we let β(u, t) = B(u, t) = ∅. An expository example of G, H and their border nodes is in Appendix G. Border nodes are useful because GET-SEQ ensures any nonseed node u activates at time t > θ(u) whenever a border node in B(u, t) is in the seedset S. Letting pj be the probability that node vj is placed in the S in a single run of Approach 3, 10 and defining the seed weight of node vj as ωj , Pt<θ(vj ) xj,t so that pj = min{1, αωj } (recall that α is our sampling bias in Approach 3), it follows that Pr[T (u) ≤ t] is related to Pvj ∈B(u,t) ωj. The following lemma therefore allows us to relate Pr[T (u) ≤ t] to the demand in the (u, t)-flow problem Pθ(u)≤τ ≤t xu,τ , Lemma 3.6 (Border node lemma). Pvj ∈B(u,t) ωj ≥ Pθ(u)≤τ ≤t xu,τ for any u ∈ V and t ≥ θ(u). which is the main task of the proof of Proposition 3.1: This lemma, proved in Appendix C.2, uses the fact the demand of the (u, t)-flow problem is upperbounded by the total capacity of the border nodes B(u, t), which is in turn upperbounded by the total seed weight of the border nodes. Armed with our border node lemma, we can move on to our main task: Proof of Proposition 3.1. One can verify, by the construction of GETSEQ, that the activation function T is always connected and for any u /∈ S, T (u) ≥ θ(u). Our main objective here is to prove that Pr[T (u) ≤ t] ∝ Pτ <t xi,t for every pair (u, t) where u ∈ V and t ≤ n. More specifically, we need to show that: Part 1. If Pt′≤t xu,t′ ≥ 1 Part 2. If Pt′≤t xu,t′ < 1 12(1+ǫ) , then Pr[T (u) ≤ t] ≥ 1 − ǫ 12(1+ǫ) , then Pr[T (u) ≤ t] ≥ (1 + ǫ)(Pt′≤t xu,t′). 4n2 . (1) Our proof relies on the observation that T (u) ≤ t if at least one of the following events hold: E1: u is seed (because GETSEQ activates all seeds at t = 1) E2: ∃ an active border node vj ∈ B(u, t) in G. (E2 implies there exist τ < t′ ≤ t such that the border node Xj,τ in H is active and GETSEQ will activate node Xu,t′ and u activates by time t.) We now use the relationship between the capacity of the border nodes and the demand of the (u, t) flow problem (namely, Pθ(u)<τ ≤t xu,τ ) to prove Part 2 of (1). The proof of Part 1 uses similar techniques, and is deferred to Appendix C.4. Given our observation above we have: Pr[T (u) ≤ t] ≥ Pr[E1 ∨ E2] ≥ 1 − min{Pr[¬E1], Pr[¬E2]} ≥ 1 − minn Pr[¬E1], 1 − 2(1 + ǫ)(cid:0) Xθ(u)≤τ ≤t ≥ 1 − minn1 − 2(1 + ǫ) Xτ <θ(u) ≥ maxn2(1 + ǫ) Xτ <θ(u) xu,τ , 2(1 + ǫ)( Xθ(u)≤τ ≤t xu,τ(cid:1)o xu,τ , 1 − 2(1 + ǫ)( Xθ(u)≤τ ≤t xu,τ )o xu,τ )o ≥ (1 + ǫ)Xτ ≤t (Lemma 3.7) (Since α ≥ 2(1 + ǫ)) xu,τ Lemma 3.7 applies the border node Lemma 3.6 to relate the probability that at least one border node is in the seedset (i.e., Pr[¬E2]) with the demand of the (u, t)-flow problem (i.e.,Pθ(u)≤τ ≤t xu,τ ). Specifically: Lemma 3.7. For every u ∈ V and t ∈ [n] where Pτ ≤t xu,τ ≤ 1 Pr[E2] = 1 − Yvj ∈B(u,t) 12(1+ǫ) we have (1 − pj) ≥ 2(1 + ǫ) Xθ(u)≤τ ≤t xu,τ Sketch of proof. The idea here is to use a first order approximation of the polynomial Qvj ∈B(i,t)(1 − pj). For the purpose of exposition, let us assume at the moment that α is negligibly small and Xvj ∈B(u,t) pj ≈ Xvj ∈B(u,t) ωj ≈ Xθ(u)≤t′≤t xu,t′ < 1 12(1 + ǫ) ≪ 1 11 where second approximation uses the border node Lemma 3.6. We can then approximate the polynomial Qvj ∈B(i,t)(1 − pj) by its first order terms, i.e., . Qvj ∈B(u,t)(1 − pj) ≈ 1 − Θ(Pvj∈B(u,t) pj) ≈ 1 − Θ(Pθ(u)≤t′≤t xu,t′), which would complete the proof. The problem with this argument is that Lemma 3.6 only guarantees thatPvj ∈B(u,t) pj > Pθ(u)≤t′≤t xu,t′. WhenPvj∈B(u,t) pj is substantially larger than the total demand of the (u, t)-flow problem, (e.g., larger than dividual pj grows, Qvj ∈B(u,t)(1 − pj) decreases, resulting in even better bounds. Roughly speaking, this to reduce the case where Pvj ∈B(u,t) pj is large, to the case where this quantity is small enough to admit a means when the first-order approximation fails, we are facing an "easier" case. Thus, our strategy will be 1), the first-order approximation becomes inaccurate. Fortunately, however, we observe that when each in- first-order approximation. Our implementation of this idea is in Appendix C.3. Asymptotic optimality of our rounding algorithm. We pay a factor of ℓ in our rounding algorithm, because we merge ℓ different {S, T } samples to make sure all the thresholds are good. But is this really necessary? In Appendix E.3.2 , we show that our rounding algorithm is asymptotically optimal in ℓ, by presenting an Ω(ℓ) integrality gap for the LP of Figure 2. Our problem instance is composed of ℓ individual gadgets, where the nodes in gadget i have thresholds chosen from a carefully constructed constant-size set. We can force these gadgets to be "independent", in that sense that if a single {S, T } sample causes one of the thresholds in gadget i to be good, we know that whp no threshold in any other gadget can be good. It follows that merging ℓ different {S, T } samples, each ensuring that a single threshold is good, is inevitable. Improvement to the approximation ratio. Observe that in our rounding procedure we require all Tj's in each of the sampled pairs {Sj, Tj} to be feasible (i.e., all nodes have to be active at the end of Tj). This requirement is not necessary because the merged T will be feasible even if only one of the Tj is feasible. We remark here that this observation can be exploited to improve the algorithm so that it returns a feasible seedset of size α · opt + β, where α = O(r(log n + ℓ)) and β = O(rℓ log n). 4 Experiments with the IP of Figure 1 Given the prevalence of heuristics like "choose the high degree nodes" in the literature on technology diffusion in communication networks (e.g., [4,10,26]), we sanity-check our approach against several heuris- tics. Our goal in the following is to give evidence that we can find solutions that are substantially different from known heuristics, and to suggest that our IP could be a promising starting point for the design of new heuristics. We considered problem instances where (a) G(V, E) is 200-node preferential attachment graph with node outdegree randomly chosen from {1, 2, 3, 4} [1], and (b) thresholds θ randomly chosen from {max{2, c}, 2c, 3c, ..., ⌈ 200 c ⌉ · c}. We ran four groups of experiments with threshold step-length parameter c fixed to 1, 5, 10, and 20 respectively. For each group, we used a fresh random preferential attachment graph, and repeated the experiment five times with a fresh random instance of the threshold functions. We solved each of these 20 problem instances using the simple IP formulation presented in Figure 1 (with the extra restriction that the highest degree node must be part of the seedset) and the Gurobi IP solver. We compared the result against five natural heuristics that iteratively pick a node u with property X from the set of inactive nodes, add u to the seedset S′, activate u, let u activate as many nodes as possible, and repeats until all nodes are active. We instantiate property X as: (a) degree: highest degree, (b) degree-threshold: highest (degree)×(threshold), (c) betweenness: highest betweenness centrality, (d) degree discounted: highest degree in the subgraph induced by the inactive nodes [13], (e) degree connected: highest degree and connected to the active nodes. 12 threshold step length: c = 1 c = 5 c = 10 c = 20 Size Jaccard Size Jaccard Size Jaccard Size Jaccard degree degree-threshold betweenness degree discounted degree connected ip solver 11.8 8.95 10.50 11.2 12.9 6.45 degree overlap betweenness overlap 0.42 0.41 0.45 0.39 0.35 1 0.44 0.47 20.9 15.40 19.65 21.55 22.65 11.15 0.36 0.42 0.39 0.34 0.29 1 0.39 0.39 24.45 19.00 24.2 25.35 25.90 13.75 0.38 0.44 0.38 0.36 0.33 1 0.37 0.37 41.75 33.25 40.85 41.60 43.25 23.45 0.46 0.55 0.47 0.45 0.44 1 0.39 0.40 Table 1: Comparison of the IP of Figure 1 to several heuristics. For each group, Table 1 presents the average seedset size and the average Jaccard index S∩S′ S∪S′ between IP seedset S and the heuristic seedset S′. We also compute the fraction of nodes in S that are also part of the top-S nodes in terms of (a) degree (the row denoted "degree overlap"), and (b) betweenness centrality ("betweenness overlap"). The results of Table 1 do indeed give evidence that our IP can return seedsets that are substantially different (and often better), than the seedsets found via heuristics. Acknowledgements. We thank Nadia Heninger, Nicole Immorlica, Prasad Raghavendra, Jennifer Rexford and Santosh Vem- pala for discussions about earlier incarnations of this model, Michael Mitzenmacher, Michael Schapira and the anonymous reviewers for comments on this draft, and Boaz Barak, Phillipa Gill, David Karger and David Kempe for helpful suggestions. 13 References [1] R. Albert and A.-L. Barab´asi. Statistical mechanics of complex networks. Rev. Mod. Phys., 74, Jan 2002. [2] N. Alon, D. Moshkovitz, and S. Safra. Algorithmic construction of sets for k-restrictions. ACM Trans. Algo- rithms, 2:153 -- 177, Apr. 2006. [3] B. Augustin, B. Krishnamurthy, and W. Willinger. IXPs: Mapped? In IMC, 2009. [4] I. Avramopoulos, M. Suchara, and J. Rexford. How small groups can secure interdomain routing. Technical report, Princeton University Comp. Sci., 2007. [5] N. Bansal, A. Blum, S. Chawla, and A. Meyerson. Approximation algorithms for deadline-tsp and vehicle routing with time-windows. In Proceedings of the thirty-sixth annual ACM symposium on Theory of computing, pages 166 -- 174. ACM, 2004. [6] B. Barak, S. Goldberg, and D. Xiao. Protocols and lower bounds for failure localization in the Internet. In IACR EUROCRYPT, 2008. [7] F. Bass. A new product growth model for consumer durables. Management Science, pages 215 -- 27, 1969. [8] A. Blum, P. Chalasani, D. Coppersmith, W. Pulleyblank, P. Raghavan, and M. Sudan. The minimum latency problem. In SDM, 1994. [9] K. Butler, T. Farley, P. McDaniel, and J. Rexford. A survey of BGP security issues and solutions. Proceedings of the IEEE, 2010. [10] H. Chang, D. Dash, A. Perrig, and H. Zhang. Modeling adoptability of secure BGP protocol. In Sigcomm, 2006. [11] N. Chen. On the approximability of influence social networks. In ACM-SIAM Symposium on Discrete Algo- rithms, 2008. [12] W. Chen, A. Collins, R. Cummings, T. Ke, Z. Liu, D. Rinc´on, X. Sun, Y. Wang, W. W., and Y. Y. Influence maximization in social networks when negative opinions may emerge and propagate. In SDM, 2011. [13] W. Chen, Y. Wang, and S. Yang. Efficient influence maximization in social networks. In Proc. 15th Conference on Knowledge discovery and data mining, KDD '09, pages 199 -- 208. ACM, 2009. [14] Y.-J. Chi, R. Oliveira, and L. Zhang. Cyclops: The Internet AS-level observatory. ACM SIGCOMM CCR, 2008. [15] D. D. Clark, J. Wroclawski, K. R. Sollins, and R. Braden. Tussle in cyberspace: defining tomorrow's Internet. Trans. on Networking, 2005. [16] S. Deering and R. Hinden. RFC 2460: Internet Protocol, Version 6 (IPv6) Specification. http://www.ietf.org/rfc/rfc2460.txt, 1998. [17] J. W. Demmel. On condition numbers and the distance to the nearest ill-posed problem. NUMERISCHE MATH- EMATIK, 51(3):251 -- 289, 1987. [18] M. Desrochers, J. Lenstra, M. Savelsbergh, and F. Soumis. Vehicle routing with time windows: Optimization and approximation. Technical report, Department of Operations Research and System Theory, Centrum voor Wiskunde en Informatica, 1987. [19] X. Dimitropoulos, D. Krioukov, M. Fomenkov, B. Huffaker, Y. Hyun, and kc claffy. AS relationships: Inference and validation. ACM SIGCOMM Computer Communication Review, JAN 2007. [20] P. Domingos and M. Richardson. Mining the network value of customers. In Proc. 7th Conf on Knowledge discovery and data mining, KDD '01, pages 57 -- 66, New York, NY, USA, 2001. ACM. [21] B. Edelman. Running out of numbers: Scarcity of ip addresses and what to do about it. Technical report, Harvard Business School, 2009. [22] H. A. Elmore, L. J. Camp, and B. P. Stephens. Diffusion and adoption of ipv6 in the arin region. In Workshop on the Economics of Internet Security, 2008. 14 [23] J. Farrell and G. Saloner. Standardization, compatibility, and innovation. The RAND Journal of Economics, pages 70 -- 83, 1985. [24] FCC. The communications security, reliability and interoperability council iii working group 6: Secure bgp deployment. Technical report, March 2012. [25] G. N. Frederickson and B. Wittman. Approximation algorithms for the traveling repairman and speeding deliv- eryman problems. Algorithmica, 62(3-4):1198 -- 1221, 2012. [26] P. Gill, M. Schapira, and S. Goldberg. Let the market drive deployment: A strategy for transistioning to BGP security. SIGCOMM'11, 2011. [27] P. Gill, M. Schapira, and S. Goldberg. Modeling on quicksand: dealing with the scarcity of ground truth in interdomain routing data. ACM SIGCOMM Computer Communication Review, 42(1):40 -- 46, 2012. [28] M. Granovetter. Threshold models of collective behavior. American Journal of Sociology, 83(6):1420 -- 1443, May 1978. [29] R. Gu´erin and K. Hosanagar. Fostering ipv6 migration through network quality differentials. SIGCOMM Com- put. Commun. Rev., 40:17 -- 25, June 2010. [30] J. Hao and J. B. Orlin. A faster algorithm for finding the minimum cut in a graph. In SODA, 1992. [31] R. Horn and C. Johnson. Matrix Analysis. Cambridge University Press, 1999. [32] M. Howarth, P. Flegkas, G. Pavlou, N. Wang, P. Trimintzios, D. Griffin, J. Griem, M. Boucadair, P. Morand, H. Asgari, and P. Georgatsos. Provisioning for inter-domain quality of service: the MESCAL approach. IEEE Communications Magazine, June 2005. [33] G. Huston. Stacking it up: Experimental observations on the operation of dual stack services. In NANOG'52, 2011. [34] Y. Jin, S. Sen, R. Guerin, K. Hosanager, and Z.-L. Zhang. Dynamics of competition between incumbent and emrging network technologies. NetEcon, 2008. [35] D. Joseph, N. Shetty, J. Chuang, and I. Stoica. Modeling the adoption of new network architectures. In CoNEXT'07: Conference on emerging Networking EXperiments and Technologies, 2007. [36] M. Katz and C. Shapiro. Network externalities, competition, and compatibility. The American economic review, 75(3):424 -- 440, 1985. [37] D. Kempe, J. Kleinberg, and E. Tardos. Maximizing the spread of influence through a social network. In ACM SIGKDD, 2003. [38] S. Kent, C. Lynn, and K. Seo. Secure border gateway protocol (S-BGP). JSAC, 2000. [39] M. Lepinski, editor. BGPSEC Protocol Specification. IETF Network Working Group, Internet-Draft, Mar. 2011. Available from http://tools.ietf.org/html/draft-lepinski-bgpsec-protocol-00. [40] J. Leskovec, J. Kleinberg, and C. Faloutsos. Graphs over time: Densification laws, shrinking diameters and possible explanations. In ACM SIGKDD International Conference on Knowledge Discovery and Data Mining (KDD), 2005. [41] D. Leventhal and A. S. Lewis. Randomized methods for linear constraints: Convergence rates and conditioning. Mathematics of Operations Research, 35(3):641 -- 654, 2010. [42] C. D. Marsan. White house issues ipv6 directive. Network World, September 28, 2010. [43] B. Metcalfe. Metcalfe's law: A network becomes more valuable as it reaches more users. InfoWorld, 1995. [44] A. Ozment and S. E. Schechter. Bootstrapping the adoption of internet security protocols. In The Fifth Workshop on the Economics of Information Security (WEIS 2006)., 2006. 15 [45] M. G. Rodriguez and B. Scholkopf. Influence maximization in continuous time diffusion networks. In 29th International Conference on Machine Learning (ICML), 2012. [46] M. Roughan, W. Willinger, O. Maennel, D. Perouli, and R. Bush. 10 lessons from 10 years of measuring and modeling the internet's autonomous systems. Selected Areas in Communications, IEEE Journal on, 29(9):1810 -- 1821, 2011. [47] T. C. Schelling. Micromotives andMacrobehavior. Norton, 1978. [48] Y. Shavitt and E. Shir. Dimes: Let the internet measure itself. ACM SIGCOMM Computer Communication Review, 35(5):71 -- 74, 2005. [49] D. P. Williamson and D. B. Shmoys. The design of approximation algorithms. Cambridge University Press, 2010. [50] A. Yaar, A. Perrig, and D. Song. SIFF: a stateless internet flow filter to mitigate ddos flooding attacks. IEEE Symposium on Security and Privacy, 2004. A Optimal connected activation sequences provide a 2-approximation This section proves Lemma 2.1. Recall that a connected activation sequence T is such that the set of active nodes at any timestep t induces a connected subgraph of G, while a connected seedset is such that all nodes in S induce a connected subgraph of G. Notice that requiring the activation sequence T to be connected is weaker than requiring a connected seedset S: since T allows a seed to activate after a non-seed, the connectivity of T can be preserved by non-seeds whose activation time occurs between the activation times of the seed nodes. We now show that the smallest seedset that gives rise to a feasible connected activation sequence is at most twice the size of the optimal seedset opt. Proof of Lemma 2.1. Given an optimal activation sequence Topt and seedset opt, we shall transform it into a connected activation sequence T . Along the way, we add nodes to the seedset in manner that increases its size by a factor of at most 2. Notation. Let Gi(T ) be the subgraph induced by the first i active nodes in T . We say a node u is a connector in an activation sequence T if the activation of u in T connects two or more disjoint connected components in GT (u)−1(T ) into a single component. Creating a connected activation sequence. Notice that an activation sequence T (·) is connected if and only if there exists no connector in the sequence. Thus, it suffices to iteratively "remove" connectors from T until no more connectors remain. To do this, we initialize our iterative procedure by setting T ← Topt. Each step of our procedure then finds the earliest connector u to activate in T , adds u to the seedset, and applies the following two transformations (sequentially): Transformation 1: First, we transform T so that every component in GT (u)(T ) is directly connected to u. Let D(u) be the subsequence of T such that every node in D(u) both activates before u, and is part of a component in GT (u)(T ) that is not connected to u. Transform T so the subsequence D(u) appears immediately after node u activates. (This does not harm the feasibility of T , because the nodes in D(u) are disconnected from the other nodes in GT (u)(T ) that activate before u.) Transformation 2: Next, we transform the activation sequence so that it is connected up to time T (u). To see how this works, assume that there are only two connected components C1 and C2 in GT (u)−1(T ), where C1 ≥ C2. Our transformation is as follows: 1. First, activate the nodes in C1 as in T (·). 16 2. Then, activate u. (This does not harm feasibility because we added u to the seedset. Connectivity is ensured because u is directly connected to C1.) 3. Finally, have all the nodes in C2 activate immediately after u; the ordering of the activations of the nodes in C2 may be arbitrary as long as it preserves connectivity. (This does not harm feasibility because (a) seed nodes may activate at any time, and (b) any non-seed v ∈ C2 must have threshold θ(v) ≤ C2 ≤ C1 and our transformation ensures that at least C1 + 1 nodes are active before any node in C2 activates.) We can easily generalize this transformation to the case where k components are connected by u by letting C1 ≥ C2 ≥ ... ≥ Ck and activate C1, u, and the rest of the components sequentially. At this point, the transformed activation sequence is feasible and connected up to time t = 1 + C1 + C2 + ... + Ck. Seedset growth. It remains to bound the growth of the seedset due to our iterative procedure. We do this in three steps. First, we observe that the number of extra nodes we added to the seedset is bounded by the number of steps in our iterative procedure. Next, we iteratively apply the following claim (proved later) to argue that the number of steps in our iterative procedure is upper bounded by number of connectors in the optimal activation sequence, Topt: Claim A.1. Let Tj be the activation sequence at the start of jth step. The number of connectors in Tj+1 is less than the number of connectors in Tj. Thus, it suffices to bound the number of connectors in Topt. Our third and final step is to show that the number of connectors in Topt is bounded by opt. To do this, we introduce a potential function Φ(t) that counts the number of disjoint connected components in GTopt(t)(T ), and argue the following: • For every connector u that activates at time t in Topt and joins two or more components, there is a corresponding decrement in Φ, i.e., Φ(t) ≤ Φ(t − 1) − 1. • Next, we have that Φ(1) = Φ(V ) = 1, since at the first timestep, there is only one active node, and at the last timestep all the nodes in the graph are active and form a single giant component. Thus, for every unit decrement in Φ at some time t, there is a corresponding unit increment in Φ at some other time t′. • Finally, for any unit increment in Φ, i.e., Φ(t′) = Φ(t′ − 1) + 1, it follows that a new connected component appears in GTopt(t′)(T ). This implies that a new seed activates at time t′. Thus, it follows that the number of unit decrements of Φ is upperbounded by the size of the seedset opt. Thus, we may conclude that the number of connectors added to the seedset in our iterative procedure is upperbounded by the number of connectors in Topt which is upperbounded by the size of the optimal seedset opt, and the lemma follows. The correctness of Claim A.1 is fairly intuitive, given that our transformations always preserve the ordering of the nodes that are not in the components joined by node u. For completeness, we include the proof here. Proof of Claim A.1. We make use of the following observation: Observation 1: τ, τ + 1, ..., V , then T and T ′ contain the same number of connectors after time τ − 1. If two activation sequences T and T ′ have a common suffix, i.e., T = T ′ for timesteps Let t = Tj(u), where u is the earliest connector in Tj. By construction, no connectors exist in Tj prior to time t. Furthermore, we can use Observation 1 to argue that Tj and Tj+1 contain the same number of connectors after time t. Thus, it suffices to show that Transformations 1 and 2 in the jth step of our iterative procedure do not introduce new connectors that activate in prior to time t. Let T ∗ be the activation sequence after Transformation 1 in the jth step of our iterative procedure, and let t′ = T ∗(u). We can see that (1) no new connectors activate before time t′ in T ∗ (since, before t′ 17 our construction ensures that T ∗ consists only of active components that are joined by u) and (2) no new connectors activate between time t′ + 1 and t inclusive (since (a) u was chosen as the earliest connector in Tj, and (b) Transformation 1 preserves the order of the nodes that activate between time t′ +1 and t inclusive in T ∗). Finally, we conclude by arguing that Transformation 2 cannot introduce new connectors by (1) applying Observation 1 to the nodes after t′ and (2) observing that after Transformation 2, the nodes that activate before t′ create a single connected component, and thus by definition cannot contain any connectors. B The augmented integer program (proof of Lemma 3.4) We prove Lemma 3.4 in three parts. First, we show that if we add following two constraints to the IP in Figure 1: (a) x1,1 = 1 and (b) that (i, t)-flow problems have feasible solutions for all i and t ≥ θ(vi), then the resulting IP returns the subset of solutions of the original IP where T (v1) = 1. We also remark on how to remove the assumption that T (v1) = 1 in the optimal T . Second, we show how to encode the flow constraints as an IP. Finally, we mention why the corresponding relaxed LP is efficiently solvable. Part 1. Any connected activation sequence satisfies the flow constraints It suffices to show that for any connected activation sequence, its corresponding integral variables {xi,t}i,t≤n satisfy the (i, t)-flow constraints for all i and t ≥ θ(vi). In what follows, we both use {xi,t}i,t≤n and T (·) to represent the activation sequence. Let {xi,t}i,t≤n be a connected activation sequence. Let us consider an arbitrary (i, t)-flow. Let τ be the time step such that xi,τ = 1. Recall that the demand in an (i, t)-flow problem is Pθ(ui)≤τ ≤t xi,τ . Therefore, when τ > t or τ < θ(vi), the demand is 0 and we are done. We only need to consider the case where θ(vi) ≤ τ ≤ t. We claim that when {xi,t}i,t≤n is a connected activation sequence, for any t and vk , T −1(t), there exists a path v1vi1vi2...vij vk such that T (v1) < T (vi1) < ... < T (vij−1 ) < T (vij ) < T (vk) = t. This can be seen by induction on t. For the base case, t = 2 and the path is v1vk. For the induction step, suppose the claim holds for every time step up to t − 1. We show that it also holds when vk activates at the t-st time step. Since {xi,t}i,t≤n is connected, there exists a vk′ such that there is an edge {vk′, vk} ∈ E and T (vk′) < T (vk). By the induction hypothesis, there must be a path v1...vk′ that connects v1 and vk′, where the activation time of each node on the path increases monotonically. Thus, the path we seek is v1vi1...vk′vk, which completes the proof of the induction step. We conclude the proof by using the claim we proved by induction. Namely, there is a path from v1 to the node vk activating at time t. It follows that we can we push a unit of flow along the path induced in the flow graph H, namely X1,1, Xi1,T (vi1 ), ..., Xij ,T (vij ), Xk,t, so we must have a feasible solution to the (i, t)-flow problem. Turning on v1. We remark that while we have been assuming that v1 is known to activate at t = 1 in the optimal solution, we can ensure this assumption holds by polynomial-time "guessing"; run the IP O(V ) times, relabeling a different node in the graph as v1 in each run, and use the run that returns the smallest seedset. Part 2. Implementation of the flow constraints. The (i, t)-flow constraints are enforced via the max- flow-min-cut theorem, i.e., by using the fact that the minimum cut between the source and the sinks is the same as the maximum flow. Thus, to ensure every (i, t)-flow problem has a feasible solution, we require the capacity for all the cuts between the source and the sinks to be larger than the demand. The actual implementation is quite straightforward, but we present the details of the IP for completeness: 18 min subject to: ∀i, t : ∀i ∀t ∀t > 1, i : xi,t Pi≤nPt<θi xi,t ∈ {0, 1} Pt≤n xi,t = 1 Pi≤n xi,t = 1 P{vi,vi′ ∈E}Pt′<t xi′,t′ ≥ xi,t x1,1 = 1 (permut'n constraints) (permut'n constraints) (connectivity constraints) (make X1,1 the source) ∀i, t ≥ θ(ui) ∀ partitions of V (H) S, S, s.t.X + ∈ S, ski,t ∈ S 1,1 Figure 2: Integer program for solving the technology diffusion problem. Pe∈δ(S,S) c(e) ≥ Pθ(ui)≤t′≤t xi,t′ (flow constraints). • The capacity constraints we have are over the nodes in H. We use standard techniques to deal with i,t connected by a directed edge of this: we replace each node Xi,t in H with two nodes X + capacity xi,t. i,t and X − • There are multiple sinks in a (i, t)-flow problem. To deal with this, for every i and t ≥ θ(vi), we introduce a new node ski,t to H that is connected to every sink Xi,θ(vi), Xi,θ(vi)+1, ..., Xi,t that sinks all the flow in the (i, t)-flow problem. Our implementation is presented in Figure 2. Let S and S be two arbitrary partition of the nodes in H. We let δ(S, S) be the cut of the partition, i.e., the set of edges whose end points are in different subsets of the partition. Also, we let c(e) be the capacity of the edge e, i.e., c({X + i,t}) = xi,t and c(e) = ∞ for all other edges. Part 3. The relaxed linear program is efficiently solvable. Our relaxed LP contains an exponential number of constraints (namely, the flow constraints). Nevertheless, we can use the ellipsoid method to find an optimal solution in polynomial time using a separation oracle [49] that validates if each of the (i, t)-flow problems over H have solutions, and if not, returns a min-cut constraint that is violated. This oracle can be constructed using algorithms in, e.g., [30]. C Missing proofs for Section 3 C.1 Proof of Lemma 3.3 (Success of a single trial) i,t, X − Recall that At is number of active nodes by time t (inclusive). We have Pr[An < n] = Pr[∃v : T (v) > n] ≤ Xv∈V Pr[T (v) > n] ≤ nǫ 4n2 = ǫ 4n . (2) The last inequality holds because of Proposition 3.1. Pr[An = n ∧ At ≥ t] ≥ Pr[At ≥ t] − Pr[An < n]. It suffices to show that Pr[At ≥ t] ≥ 3ǫ Let us partition V into heavy nodes H, and light nodes L. We put v ∈ H when Pτ ≤t xv,τ ≥ and v ∈ L otherwise. Let's consider two cases, based on the "weight" of the light nodes ρt: 4n since 1 12(1+ǫ) , ρt = Xv∈LXτ ≤t xv,τ (3) Case 1. ρt < 1 (The light nodes are very light). Recalling that the permutation constraints of our LP impose that Pv∈V Pτ <t xv,τ = t, it follows that 19 t − 1 < t − ρt = Xv∈V Xτ <t xv,τ −Xv∈LXτ ≤t xv,τ = Xv∈HXτ ≤t xv,τ ≤ t Using the first and last inequalities and taking the ceiling, we get that H ≥ lPv∈H Pτ ≤t xv,τm = t. Since H ≥ t, if every node in H activates before time t we know that At ≥ t. We write Pr[At ≥ t] ≥ Pr[T (v) ≤ t, ∀v ∈ H] ≥ 1 − Xv∈H Pr[T (v) > t] ≥ 1 − ǫ 4n , (4) where the last inequality in (4) holds because of Proposition 3.1. Case 2. ρt ≥ 1 (The light nodes are not very light). We start by defining two events. E1 is the event that all the heavy nodes are active by time t, i.e., T (v) ≤ t ∀v ∈ H. E2 is the event that at least ρt light nodes are on by time t, i.e., {v ∈ H ∧ T (v) ≤ t} > ρt. When both E1 and E2 occur, we have At ≥ H + ρt ≥ Xv∈HXτ ≤t xv,τ +Xv∈LXτ ≤t xv,τ = t where both the second inequality and the last equality use the permutation constraints of the LP. It follows that Pr[At > t] ≥ Pr[E1 ∧ E2] ≥ Pr[E2] − Pr[¬E1]. We now bound each event individually. Let's start by bounding Pr[E2]. Letting I(·) be an indicator variable that sets to 1 iff the parameter is true, we have that E[Pv∈L I(T (v) ≤ t)] = Pv∈L Pr[T (v) ≤ t] ≥ Pv∈L(cid:16)(1 + ǫ)Pt′≤t xv,t′(cid:17) = (1 + ǫ)ρt where the inequality uses Proposition 3.1 as usual. Meanwhile, using the law of total probability we get E[Xv∈L I(T (v) ≤ t)] ≤ Pr[E2]n + Pr[¬E2]ρt ≤ Pr[E2]n + ρt (5) (6) Combining (5)-(6) we find that Pr[E2] ≥ ǫρt n . Next, we bound Pr[E1] by observing that n ≥ ǫ Pr[¬E1] ≤ Xv∈H Pr[T (v) > t] ≤ ǫ 4n using Proposition 3.1 for the last inequality again. Finally, we combine both bounds to conclude that Pr[At > t] ≥ Pr[E1 ∧ E2] ≥ Pr[E2] − Pr[¬E1] ≥ 3ǫ 4n as required. 20 C.2 Proof of Lemma 3.6 (Border node lemma) Let us decompose the representative flow Fi,t into paths (in an arbitrary but consistent manner) P1, P2, ..., Pq, and let fk be the volume of the flow on path Pk. Xθ(vi)≤τ ≤t xi,τ = Xk fk (the demand in the (i, t) flow problem is satisfied) fk (multiple border(Pk) can map to a single Xj,τ ) xj,τ = XXj,τ ∈β(i,t) Xborder(Pk)=Xj,τ ≤ XXj,τ ∈β(i,t) = Xvj ∈B(i,t) Xτ s.t. Xj,τ ∈β(i,j) ≤ Xvj ∈B(i,t) Xτ ≤θ(vj ) = Xvj ∈B(i,t) xj,τ wj xj,τ (bounding capacity of Xj,τ ) (translating from H to G) (τ s.t. Xj,τ ∈ β(i, j) ⇒ τ ≤ θ(vj)) (definition of wj) Notice that the last four lines give the total seed weight of the border nodes as an upper bound on their total capacity. C.3 Proof of Lemma 3.7 Proof of Lemma 3.7. We shall find a non-negative sequence p′ j) j (vj ∈ B(u, t)) such that • Condition 1: Qvj ∈B(u,t)(1 − pj) ≤ Qvj∈B(u,t)(1 − p′ • Condition 2: Pj∈B(u,t) p′ j = 4(1 + ǫ)Pθ(u)≤τ ≤t xu,τ . When both conditions hold, we can bound Qvj ∈B(u,t)(1 − pj) by Qvj ∈B(u,t)(1 − p′ j), which can then be approximated by its first-order terms. We use existential arguments to find the sequences p′ j (for each vj ∈ B(u, t)): We start by recalling that pj = min{1, αωj } and α > 4(1 + ǫ). It follows that when ωj ≥ 1 4(1+ǫ) for some vj ∈ B(u, t), the pj = 1 and the lemma trivially holds. Thus, we may assume that 4(1 + ǫ)ωj ≤ 1 for all vj ∈ B(u, t), and we can write pj ≥ 4(1 + ǫ) Xvj ∈B(u,t) ωj ≥ 4(1 + ǫ) Xθ(u)≤τ ≤t Xvj ∈B(u,t) xu,τ . where the second inequality uses Lemma 3.6. We now know that there exists a sequence p′ j such that pj ≥ p′ we may complete the proof with the following first-order approximation: which meets Condition 1 and Condition 2. It follows that Qvj ∈B(u,t)(1 − pj) ≤ Qvj∈B(u,t)(1 − p′ Lemma C.1 (First order approximation). Let x1, x2, ..., xk be real positive values such that Pi≤k xi ≤ 1. j), and Then j andPj∈B(u,t) p′ j = 4(1+ǫ)Pθ(u)≤τ ≤t xu,τ , (1 − xi) ≤ 1 − Yi≤k 1 2  Xi≤k xi  . js, and use the fact that When we substitute the xi's in Lemma C.1 with p′ j = 4(1 + ǫ) Xθ(u)≤τ ≤t Xj∈B(u,t) p′ 1 12(1+ǫ) = 1 3 < 1. xu,τ ≤ 4(1 + ǫ) 21 Proof of Lemma C.1 (First order approximation). Let x1, x2, ..., xk be real positive values such that we complete the proof because Qvj ∈B(u,t)(1 − p′ Pi≤k xi ≤ 1. Notice that for any 0 ≤ x ≤ 1, we have (1 − x) ≤ e−x. Let s , Pi≤k xi. We have 2 · 4(1 + ǫ)Pθ(vj )≤τ ≤t xu,τ j) ≤ 1 − 1 s2 2 ≤ 1 − s(1 − ) = 1 − Yi≤k (1 − xi) ≤ Yi≤k exp(xi) = exp(Xi≤k xk) = exp(s) ≤ 1 − s + C.4 First part of Proposition 3.1 1 2 s 2 . We now prove the first item in (1), i.e., we consider a pair (u, t) such that Pτ ≤t xu,τ ≥ 1 consider two cases. 12(1+ǫ) . Let us Pr[T (u) ≤ t] = 1. Case 1. Pτ ≤min{θ(u)−1,t} xu,τ ≥ Case 2. Pτ ≤min{θ(u)−1,t} xu,τ < 1 we use the border node Lemma 3.6 to get 24(1+ǫ) . In this case, pu = 1 and u is always selected as a seed. Thus, 24(1+ǫ) In this case, we can see thatPθ(u)≤τ ≤t xu,τ ≥ 1 24(1+ǫ) . Therefore, 1 Xvj ∈B(u,t) ωj ≥ 1 24(1 + ǫ) . (7) At this point, our analysis deviates from the analysis for the second part of Proposition 3.1. There, the Now, recall that Pr[T (u) ≤ t] ≥ Pr[E2] = 1 − Qvj ∈B(u,t)(1 − pj). Therefore, it suffices to prove that Qvj ∈B(u,t)(1 − pj) ≤ ǫ 4n2 . pj values were small enough to allow Qvj ∈B(u,t)(1 − pj) to be approximated using only first-order terms. Here, we are dealing with the case where pj's are large. Thus, Qvj ∈B(u,t)(1 − pj) decays exponentially, and it is more appropriate to approximate it using exponential functions. By using (7) and the following approximation Lemma C.2 (with λ as α) we can see that indeedQvj ∈B(i,t)(1 − pj) ≤ ǫ 4n2 , which completes Lemma C.2. Let ǫ be an arbitrary constant. Let x1, ..., xk be numbers between [0, 1] such thatPi≤k xi = s, ǫ ) and pi = min{λxi, 1}. It follows that 24(1+ǫ) . Let λ = 24(1 + ǫ) ln( 4n2 where s ≥ 1 the proof. (1 − min{λxi, 1}) ≤ Yi≤n ǫ 4n2 . Proof of Lemma C.2. Let us consider two cases over the values of xi. In the first case, there exists some xi such that λxi ≥ 1. For this case, we have Qi≤n(1 − min{λxi, 1}) = 0 ≤ ǫ 4n2 . maximized when x1 = x2 = ... = xk = s In the second case, where all xi are less than 1/λ, the quantity Qi≤k(1 − pi) = Qi≤k(1 − λxi) is k . In other words, (1 − λxi) ≤ (cid:18)1 − Yi≤k λs k (cid:19)k = (cid:18)1 − λs k (cid:19) k λs λs ≤ e−λs ≤ exp(− λ 24(1 + ǫ) ) = exp(− ln( 4n2 ǫ )) = ǫ 4n2 . 22 D Proof of Corollary 1.3 Let us consider an arbitrary technology diffusion problem Π = {G, θ}. Let Π+ and Π− be the cor- responding diffusion problems defined in Definition 1.2. Recall that opt is the optimal solution for Π, opt+ is the optimal solution for Π+ and opt− is the optimal solution for Π−. Let P , {⌊1 + ǫ⌋, ⌊(1 + ǫ)2⌋, ..., ⌊(1 + ǫ)q⌋}, where q = log1+ǫ n + 1. We next define a new technology diffusion instance Π′ = {G, θ′} that uses the same graph and θ′(u) (for each u) is the smallest number in P that is larger than θ(u). Notice that θ′(u) ≤ (1 + ǫ)θ(u). Let opt′ be the size of optimal seed set for Π′. We can run our approximation algorithm on Π′ and get a solution, whose size is at most O(log2 n · r · opt′) since the number of thresholds in Π′ is log n. Because θ′(u) ≥ θ(u) for all u, a feasible solution in Π′ is also a feasible solution in Π. Thus, the seedset returned by our algorithm is feasible and opt ≤ opt′. Sim- ilarly, we can see that opt− ≤ opt and opt′ ≤ opt+. Therefore, the seedset size can be expressed as O(log2 n · ropt opt′ E Lower bounds This appendix presents our lower bounds, that can be summarized as follows. opt− ) = O(κ(Π, ǫ)(log2 n) · ropt). opt ) = O(log2 n · ropt opt+ 1. Computational barrier: the technology diffusion problem is at least as hard as a Set Cover problem, so that our problem does not admit any o(lnV )-approximation algorithm. 2. Combinatorial barrier: in the worst case, the optimal solution with a connected seedset could be Ω(r) times larger than the optimal solution. 3. Integrality gaps: The simple IP (Figure 1 discussed in Section 2) has an Ω(n) integrality gap. The augmented IP (Section 3.2.2 and Figure 2 of Appendix B) has an Ω(ℓ) integrality gap. E.1 Computational barrier This section proves that the technology diffusion problem is at least as hard as the set cover problem. Let us recall the definition (of the optimization version) of the set cover problem: given a finite universe U and a family S of subsets of U, we are interested in finding the smallest subset T of S such that T is a cover of U, i.e. ST ∈T T = U. The set cover cannot be approximated within a factor of (1 − o(1)) ln n unless NP has quasi-polynomial time algorithm (see [2] and references therein). We have the following lemma. Lemma E.1. Given an α-approximation algorithm for the technology diffusion problem with constant num- ber of threshold values θ ≥ 2, and constant graph diameter r ≥ 3, we can obtain an O(α)-approximation algorithm for the set cover problem. Moreover, the reduction holds even if the seedset in the technology diffusion problem is required to be connected. Thus, we can see that there is no c ln n approximation algorithm (for some constant c) for the technol- ogy diffusion problem. Proof of Lemma E.1. Let us consider an arbitrary set cover instance (U , T), where m = T is the number of sets in T. The reduction. Figure 3: We construct a technology diffusion problem as described below, and illustrated in • The vertex set consists of the following types of vertices: 1. The set type: for each T ∈ T, we shall construct a node vT in the technology network. 2. The element type: for each e ∈ U, we shall construct m + 1 nodes ve,1, ve,2, ..., ve,m+1. • The edge set consists of the following edges: 1. For each T ∈ T and e ∈ T , we add the edges {vT , ve,1}, {vT , ve,2}, ..., {vT , ve,m+1}. 23 Set-type vertices vT1 vT1 … vTm Element-type vertices … ve1 ve2 … Vem+1 ve'1 Ve'2 … Vem+1 m+1 n Figure 3: Reduction. 2. The set type vertices are connected as a clique. (For each T 6= T ′ ∈ T, we add the edge {uT , uT ′}). • The thresholds θ(·) are set as follows, 1. For any e ∈ U and i ≤ m + 1, we set θ(ve,i) = 2. 2. For every T ∈ T, we set θ(vT ) = (m + 1)n + 1. Properties of the reduction. Notice that our technology diffusion problem has only two types of threshold values. Furthermore, the diameter of the graph we form is exactly 3 hops (in terms of edges); the maximum distance in this graph is from one ve,i node to another. Finally, we show below that the seedset must consist of set-type vertices. Since these vertices form a clique, it follows that there exists an optimal seedset that is connected. Correctness. To conclude that the size of the optimal seed set is the same as the size of the optimal cover (which also means that our reduction is approximation-preserving), we establish the following: Item 1. For any feasible cover S in the set cover problem, the corresponding seed set {vS : S ∈ S} is a feasible solution for the technology diffusion problem. Item 2. Any feasible seedset in the technology diffusion problem that only consists of set-type vertices corresponds to a feasible cover in the set cover problem. Item 3. Given a feasible seedset that consists of element type vertices, there is a feasible seedset of equal or smaller size that consists only of set type vertices. Since the set type vertices form a clique, we have that the optimal solution for the technology diffusion problem is also a connected one. Item 1. To show the first item, we simply walk through the activation process: When S is a cover, let the seedset be vTi for all Ti ∈ S. Notice that this seedset is connected. Upon activating the seedset, the vertices ue,i for all e ∈ U and i ≤ m + 1 are activated because they are connected to at least one active seed. Now, there are (m + 1)n active nodes, so the rest of the set type vertices are activated. Item 2. To show the second item, we consider an arbitrary seedset that only consists of the set type vertices: U = {vT1, vT2, ..., vTk }, where T1, ..., Tk ∈ T. We shall show that if T1, ..., Tk is not a cover, then the seed set cannot be feasible (i.e., some nodes will remain inactive in the technology diffusion problem). Let e ∈ U / (∪j≤kTj) be an element that is not covered by the sets in {T1, ..., Tk}. Let us consider the nodes ve,1, ve,2, ..., ve,m+1, and node vT for each T /∈ {T1, ..., Tk} in the technology diffusion problem. We claim that none of these vertices will be activated with seedset U. Suppose, for the sake of contradiction, 24 that one or more of these vertices are activated, and consider the first activated vertex among them. There are two cases: Case 1. vT (T /∈ T) is activated first. This is impossible: when ve,i (i ≤ m + 1) are not activated, the number of activated nodes is at most (n − 1)(m + 1) + m < (m + 1)n. Case 2. ve,i (i ≤ m + 1) is activated first. This is impossible because ve,i is only connected with vT , where T /∈ {T1, ..., Tk} and none these set type vertices are activated. Item 3. Finally, we move onto the third item. Let us consider a feasible seedset F that does not consist of only set type vertices. We show that we can easily remove the element type vertices in F : let ve,i be an arbitrary vertex in F . Then we can remove ve,i from F and add an vT to F such that e ∈ T . This does not increase the cardinality of F . Furthermore, ve,i would still be activated, which implies that the updated F is still be a feasible seed set. E.2 Combinatorial barrier Lemma E.2. For any fixed integer r, there exists an instance of technology diffusion problem {G, θ} such that (a) the diameter of G is Θ(r), and (b) the optimal connected seedset is at least Ω(r) larger than the optimal seedset. Proof of Lemma E.2. Let r > 0 be an arbitrary integer. We define graph Gr as follows (see Figure 4): • The vertex set is {v1, ..., v2r+1}. • The edge set is {{vi, vi+1} : 1 ≤ i < 2r + 1}. The threshold function shall be defined as follows, • θ(v1) = θ(v2r+1) = 2 and θ(vr+1) = 2r + 1. • For 1 < i ≤ r, θ(vi) = i. • For r + 2 ≤ i < 2r + 1, θ(vi) = 2r + 2 − i. It is straightforward to see that the diameter of the graph is 2r = Θ(r). It remains to verify that the optimal connected solution is Θ(r) times larger than the optimal solution. It's easy to see that {v1, v2r+1} is a feasible seedset and therefore, the size of the optimal seed set is O(1). We next show that any feasible connected set has size Ω(r). Since the seedset must be connected, wlog we can assume that the seedset is {vi, vi+1, ..., vj } and by symmetry i ≤ r + 1. When j < r + 1, node vr+1 will never activate (because vr+1 has threshold 2r + 1, it only activates when all other nodes are active, but in this case all r nodes to the right of vr+1 are inactive). It follows that a feasible seedset requires j ≥ r + 1. When i = 1, the size of the seedset is Θ(r) and the lemma follows. So, we need only consider the case where i > 1: symmetry allows us to assume wlog that r + 1 − i ≥ j − (r + 1) i.e., θ(vj+1) ≥ θ(vi−1). Therefore, since we have j − i + 1 nodes in the seedset, a necessary condition for this seedset to be feasible is thus j − i + 1 ≥ i − 2. Using the fact that j ≥ r + 1, we get i ≤ r/2 + 2 and j − i = Ω(r), which completes our proof. One drawback of this construction is that ℓ = Θ(n). We may modify θ(·) so that ℓ = O(1) (thus ensuring that our lower bound depends on graph diameter r, rather than the number of thresholds ℓ): • When i ≤ n, set θ(ui) = max{2⌊log2 i⌋, 2}, • when i = n + 1, set θ(ui) = 2n + 1, and • When i > n, set θ(ui) = max{2⌊log2(2n+2−i)⌋, 2}. One can use similar arguments to show that the size of the optimal seedset is O(1) while the size of the optimal connected seedset is Θ(r). 25 Linegraph v 1 v 2 v 3 r… v v r+1 v r+2 … v 2r-1 v 2r v 2r+1 1 =2 2 =2 3 =3 … =r r r+1 =2r+1 =r … =3 =2 2r 2r-1 2r+1 =2 r+2 Figure 4: An instance of the technology diffusion problem for the proof of Lemma E.2. Integrality gap E.3 E.3.1 Integrality gap for the simple IP of Figure 1 We construct a problem instance with ℓ = O(1) where the solution returned by the simple IP of Figure 1 is O(1), while the optimal seedset has size Θ(n), implying an integrality gap that is polynomial in n = V . The problem instance. We let w and h be parameters of the problem instance {G, θ}. These parameters control the shape of the graph G and the size of the integrality gap. We will decide the parameters at the end to maximize the integrality gap. The graph G (see Figure 5) has a node set of size n = wh + h + 1 that consists of the following nodes: • The root node R. • The "seed candidates" {s1, ..., sh}. • The "tail nodes" vi,j for i ≤ h and j ≤ w. The edge set consists of the following two types of edges: • all the "seed candidates" si (i ∈ [h]) are connected with the root R. • for any specific i ∈ [h], the nodes si, vi,1, vi,2, ..., vi,w form a chain. In other words, {si, vi,1} ∈ E and {vi,j, vi,j+1} ∈ E for 1 ≤ j ≤ w − 1. Hereafter, we shall refer to the chain si, vi,1, ..., vi,w as the i-th tail of the graph. The threshold function θ is specified as follows: • θ(R) = n. • for any si we have θ(si) = n − h + 2. • for any vi,j we have θ(vi,j) = 2. To exhibit the integrality gap, we shall first construct a feasible fractional solution of constant size, and then show that the optimal integral solution gives rise to a seedset of size Θ(h). The fractional solution. Table 2 describes a feasible fractional solution of constant size. We now walk through this solution. In the solution, we group the rows in the following way: • The first row corresponds with the root node. • The rest of the rows are grouped by "stripes". A stripe consists of a seed candidate and its correspond- ing tail. For example, the first stripe consists of the rows for s1, v1,1, ..., v1,w. We shall also divide the columns into two parts. The first part is the "false propagation" stage, consist- ing of 2 + wh columns where we use a small fractional seed set to activate the tail nodes. The second part is the "completion stage" consisting of h − 1 rows , where we fill in the residual mass of the nodes so that the permutation constraints are met. Variable assignments in the fractional solution. We now describe the assignments in Table 2. • xR,1 = 1, i.e. the root is first activated. • Let ǫ , 1/h. For each stripe {si, vi,1, ..., vi,w}, we assign values in the false propagation region as follows: xsi,2 = ǫ and xvi,j ,j+2+kw = ǫ for all j ≤ w and 0 ≤ k < h. The rest of the variables in this region are set to 0. This assignment exhibits a periodic pattern, so that mass can circulate back and forth along a tail until all nodes in the tail are activated at the end of the false propagation stage. (Refer to the underlined values in the first stripe of Table 2). 26 Table 2: A fractional solution for the simple IP formulation R s1 v1,1 v1,2 v1,3 ... v1,w s2 v2,1 v2,2 v2,3 ... v2,w s3 v3,1 v3,2 v3,3 ... v3,w ... sh vh,1 vh,2 v3,3 ... vh,w 1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 ... 0 0 0 0 0 0 ǫ 0 0 0 0 ǫ 0 0 0 0 ǫ 0 0 0 0 ... ǫ 0 0 0 0 0 0 ǫ 0 0 0 0 ǫ 0 0 0 0 ǫ 0 0 0 0 ǫ 0 0 0 0 0 0 ǫ 0 0 0 0 0 ǫ 0 0 0 0 ǫ First cycle . . . 0 0 . . . . . . 0 . . . ǫ 0 . . . . .. . . . . . . . . . . . . . . . . .. . . . . . . . . . . . . . . . . .. . . . ... . . . . . . . . . . . . . .. . . . 0 0 0 0 ǫ 0 0 0 ǫ 0 0 0 0 ǫ 0 0 0 0 0 ǫ 0 0 0 0 0 0 0 ǫ 0 0 0 0 ǫ 0 0 0 0 ǫ 0 0 0 0 ǫ 0 0 ǫ 0 0 0 0 ǫ 0 0 0 0 ǫ 0 0 0 0 ǫ 0 0 0 2 7 1 s t s t r i p e h - t h s t r i p e 2 n d s t r i p e 3 r d s t r i p e         0 0 0 ǫ 0 0 0 0 ǫ 0 0 0 0 ǫ 0 0 0 0 0 0 ǫ 0 0 0 0 ǫ 0 0 0 0 ǫ 0 Second cycle 0 0 0 ǫ 0 0 0 0 0 ǫ h − 2 other cycles 0 0 0 0 0 ǫ 0 0 0 0 ǫ 0 0 0 0 ǫ ... 0 0 0 0 ǫ . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 0 1 − ǫ 0 0 0 0 0 0 0 0 Completion stage . . . . . . . . . . . . . . . 0 0 0 0 0 0 1 − 2ǫ 0 0 0 0 0 0 0 0 0 2ǫ 0 0 0 0 0 0 0 0 0 0 1 − 3ǫ 0 0 0 0 0 0 0 0 0 . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . ... . . . . . . . . . . . . . . . . . . 0 ǫ 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 (h − 1)ǫ 0 0 0 0 . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . ... . . . . . . . . . . . . . . . . . . Root vertex Seed candidates Tail nodes s1 v1,1 v1,2 … v1,w s2 v2,1 v2,2 … v2,w R … … h sh vh,1 vh,2 … vh,w w Figure 5: The graph for the hard instance with Ω(h) integrality gap • Finally, we fill in the variables in the completion stage so that the permutation constraints are met. Notice that at time n − h + 2, only the rows that correspond with the seed candidates si (i ≤ h) do not sum up to 1. We use the columns in the completion stage to fill in the extra mass using a "greedy" approach. In other words, at the column n − h + 2, we first fill in the unused mass (namely 1 − ǫ) from s1. Then we fill in the unused mass from s2 as much as possible, subject to the constraint that the column sums to 1 (namely ǫ). Next, we move to the next column (the n − h + 3-rd column). Then we fill in the mass from s2 and as much mass as possible from s3 to this column. This process continues until all mass from si (i ≤ h) is filled. The fractional solution is feasible. Next, we argue that such assignments are feasible. Since, we satisfied the permutation constraints by construction (Table 2), we only argue that the connectivity constraints are met. • We need to start thinking about connectivity when t = 2. At this time step, the connectivity constraints are met because all the seed candidates are connected to the root R, which is activated at time t = 1. • Next, we argue that the connectivity constraints are met in the propagation stage. Let us consider the first cycle in the propagation stage. In the first time step of the first cycle, an ǫ-fraction of mass is activated at vi,1 for all i ≤ h. Since vi,1 is connected with si, and an ǫ portion of si is active prior to the beginning of the 1st cycle, the connectivity constraint is met for this step. For the rest of the timesteps of the first cycle, note that by the time we assign ǫ to the node vi,j, an ǫ portion of mass is already activated at vi,j−1. Since {vi,j−1, vi,j} ∈ E for all j < w, the connectivity constraints are met for the entire first cycle. The argument for the remaining cycles proceeds in a similar manner. • Finally, showing the connectivity holds in the completion stage is trivial: this follows because only seed candidates activate at the this stage, and seed candidates are all connected to the root which has been fully activated since t = 1. Hence, we can conclude that the fractional solution in Table 2 is feasible. The integral solution. To prove that the optimal integral solution is a seedset of size O(h), we show that 28 any seedset of size less than h rather arbitrarily and is not optimized. 5 will fail to activate all the nodes in the graph. Here, the constant 1 5 is chosen First, we notice that for any feasible set S that contains one or more tail nodes, we can transform it into a feasible set S′ such that (a) S′ ≤ S and (b) no tail nodes are in S′. To construct the new seedset, replace each tail node vi,j in S by it's parent seed candidate si. Since the activation of si always causes the activation of vi,j for any j, it follows that S′ is a feasible seedset whenever S is a feasible seedset. Thus, we may focus on the seedset that contains only R and/or seed candidates. Wlog, we may assume }. Next, we argue that the seedset U fails to activate all the 5 and j ≤ w) with parent seed candidates in 5 . Now we 5 ) that are not in U cannot be the seed set is a subset in U = {R, s1, ..., s h nodes in the graph. First, we can see that all the tails vi,j (i ≤ h U will be active. After they are activated, the total number of activated nodes will be h argue that no other nodes are active because (a) all seed candidates si (i > h activated since the following holds 5 + 1 + wh 5 5 + 1 + wh ( h 5 ) + 1 < θ(si) = n − h + 2 (8) for sufficiently large constant w and sufficiently large n, and (b) all tail nodes vi,j (i > h be activated until their parent seed candidate is active. A Θ(n) integrality gap. We can conclude that the integral solution has a seedset size of O(h) while the fractional solution is O(1). When we set w be a sufficiently large constant and h = Θ(n) (we only need to ensure that (8) holds), our integrality gap is Θ(n). E.3.2 Integrality gap for the augmented IP of Figure 2. 5 and j ≤ w) cannot In this section, we shall prove the following theorem. Theorem E.3. Consider the augmented linear program of of Figure 2. For any sufficiently large n and any ℓ ≤ cn1/3, where c is a suitable constant, there exists a problem instance with an Ω(ℓ) integrality gap. The problem instance. To simplify the exposition, we will assume that our problem instance {G, θ} is such that our graph G has V = n nodes, where n − 1 is a multiple of ℓ, and the range of θ is 2ℓ + 2 different threshold values. We shall let w be the integer such that (w + 2)ℓ + 1 = n, and let ǫ , 1/ℓ. Our graph G is described as follows (See Figure 6): • the node set consists of the following: -- The root vertex R. -- The set of "seed candidate" {s1, ..., sℓ}. -- The set of "blockers" {b1, ..., bℓ}. -- The set of "tails" vi,j, where i ≤ ℓ and j ≤ w. • The edge set consists of the following three types of edges -- There is an edge between the root and any seed candidate, i.e. {R, si} ∈ E for all i ≤ ℓ. -- There is an edge between the root and any blocker, i.e. {R, bi} ∈ E for all i ≤ ℓ. -- For any i, j, we have {si, vi,j} ∈ E and {bi, vi,j} ∈ E. In what follows, we shall also refer to the subgraph induced by si, bi, vi,1, ..., vi,w as the i-th gadget of the graph. We set the threshold function θ as follows: • θ(R) = n. • θ(si) = (w + 1)ℓ + 3. • θ(vi,j) = (i − 1)(w + 1) + 3. • θ(bi) = (i − 1)(w + 1) + w/ℓ + 2. 29 R s1 b2 s2 … b2 sk bk … v1,w v1,1 v2,1 … v2,w vk,1 … vk,w Figure 6: The graph for the hard instance with Ω(k) integrality gap In what follows, we shall first show that a feasible solution of size O(1) exists for the relaxed LP. Then we shall show that the optimal integral solution is a seedset of size Ω(ℓ). The fractional solution. We now construct feasible fractional solution of size O(1). See the table in Figure 7. The intuition behind our construction is to activate the root R at the first time step, i.e. xR,1 = 1, and then activate an ǫ-portion of each seed candidate in the second time step. This total of 1 + ℓǫ = 2 mass will be the size of the entire (fractional) seedset. We will make sure that the rest of the node's mass will activate after their thresholds, and will therefore not contribute to the size of the fraction solution. We divide our construction into two time stages. The first is the "false propagation" stage, where all the nodes except for the seed candidates will be fully activated. The second is the "completion stage" where the remaining inactivated mass from the seed candidates will be activated. Next, we describe each of these two stages in detail. False propagation stage. The false propagation stage consists of (w + 1) × ℓ time steps, divided into ℓ blocks, each consisting of (w + 1) time steps. Notice that the thresholds of the seed candidates θ(si) ∀i occur exactly after the false propogation stage ends. During i-th block of the false propagation stage, the blocker bi and tail nodes vi,j ∀j ∈ [w] in i-th gadget will be fully activated. Since there are exactly (w + 1) such nodes, the i-th block is a (w + 1) × (w + 1) matrix, the only non-zero variables in the i-th block will be those of the blocker and tail nodes in the i-th gadget. These variables are expressed as the sub-matrices M in Figure 7. The variable assignments in M. We next describe the variable assignments in M for the i-th block, as shown in Table 3. Our variable assignments will keep the invariance that before the i-th block, all nodes in the k-th gadget, except for the seed candidate nodes, are fully activated for every k ≤ i − 1. The i-th block begins at the 3 + (i − 1)(w + 1)-th time step and ends at the 2 + i(w + 1)-th time step. The assignments in M are divided into multiple cycles, each of which spans w/ℓ = ǫw time steps. Notice that the i-th block will contain in total ℓ cycles, and one extra time step that does not belong to any cycle. This extra time step will be inserted between the end of the first cycle and the beginning of the second cycle and will be used to activate the blocker bi, i.e., xbi,3+(i−1)(w+1)+w/ℓ = 1. In each cycle, every node's mass needs to be incremented by ǫ. We do this using a greedy construction, incrementing the mass of ℓ tail nodes by ǫ in each timestep of a given cycle, so that the column constraints are met for this cycle. For this reason, we need w ℓ time steps to fully activate all the tail nodes; this follows because there are in total ℓ cycles, so the sum of the active portion of any tail node vi,j in the i-th block is ǫ · ℓ = 1, so that vi,j is completely activated. Feasibility of the assignments. We show why our variable assignments at the propagation stage are feasible, and do not increase the mass of the fractional seedset. Our analysis is based on induction. Recall our 30 Propagation Stage . . . M . . . 0 0 0 0 R s1 s2 ... sℓ b1 v1,1 ... v1,w b2 v2,1 ... v2,w ... bℓ vℓ,1 ... vℓ,w 1 0 0 ... 0 0 0 ... 0 0 0 ... 0 ... 0 0 ... 0 0 ǫ ǫ ... ǫ 0 0 ... 0 0 0 ... 0 ... 0 0 ... 0 0 0 0 0 . . . . . . . . . ... . . . M 0 ... 0 . . . . . . . . . . . . . . . 0 ... 0 0 0 0 0 . . . . . . . . . . . . . . . 0 0 . . . ... . . . . . . . . . M Completion Stage 0 0 1 − 2ǫ . . . . . . . . . 0 0 0 0 0 0 0 0 0 0 0 0 0 . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 0 0 0 0 0 0 0 0 0 0 0 0 0 (ℓ − 1)ǫ 0 0 0 0 0 0 0 0 0 0 1 − ǫ ǫ 0 0 0 0 0 0 0 0 0 0 Figure 7: Feasible fractional assignments for the flow based linear program. invariance that prior to the start of the i-th block, all blockers and tail nodes in the j-th gadget (k ≤ i − 1) are fully activated. We shall show that if the invariance holds up to the (i − 1)st block, the variable assignments in the i-th block are feasible (and do not introduce any mass to the seedset). Suppose that the invariance holds up to the (i − 1)-st block. Then we have that: • the seedset does not increase, because mass for each node is assigned after its corresponding threshold. (This follows since the i-th block starts at timestep (w + 1)(i − 1) + 3 and the tail nodes have θ(vi,j) = (w + 1)(i − 1) + 3. Similarly, the blocker bi is activated at time (w + 1)(i − 1) + 3 + w/ℓ while θ(bi) = (w + 1)(i − 1) + 3 + w/ℓ.) • the flow constraints are met. During the first cycle, (timesteps (w + 1)(i − 1) + 3 to (w + 1)(i − 1) + w/ℓ + 2), we may push a flow of size ǫ to any tail node vi,j through the path R-si-vi,j since the seed candidate si has is an ǫ-portion active. Next, at timestep (w + 1)(i − 1) + w/ℓ + 3 the blocker bi must receive a unit flow; this is feasible since bi is directly connected to the root that is fully active at t = 1. Finally, during the remaining cycles (timesteps (w + 1)(i − 1) + w/ℓ + 4 to (w + 1)i + 2) we may continue to fully activate the tail nodes vi,j by pushing a up to a unit of flow through the path R-bi-vi,j. Thus, we may conclude that the assignments at the i-th block are feasible and will not increase the size of the seedset, which further implies that the invariance also holds for the i-th block. Completion stage. We now describe the assignments for the completion stage. The completion stage starts at time t2 , 3 + ℓ(w + 1). Since t2 ≥ θ(si), activating the seed candidates in this stage does not increase the side of the seedset. Note further that the only rows that do not sum to 1 correspond to the seed candidates. We again take a greedy approach to fill in the residual mass from the seed candidates (similar to that used in the completion stage of the integrality gap presented in Section E.3.1). At column t2, we let xs1,t2 = 1 − ǫ 31 and xs2,t2 = ǫ, filling in the unused row mass from s1, and filling in the unused row mass of s2 as much as possible subject to the column constraint of column t2. We repeat this process for each of the ℓ − 1 remaining columns, until all mass from the seed candidates is used up. By construction, the completion stage satisfies the row and column permutation constraints, and does not increase the size of the fractional seedset (since all seed candidates activate after their thresholds). Finally, the flow constraints are satisfied since we can push up to a unit of flow to each si along its direct connection to R. The integral solution. To prove that the optimal integral solution is a seedset of size Ω(ℓ), we show that any seedset of size ℓ 3 fails to activate the whole graph when w ≥ ck2 for some suitable constant c. Fix an arbitrary seedset S. Let I , {i : ∃v ∈ S s.t. v is in the i-th gadget} . (9) We shall write I = {i1, ..., iq}, where q ≤ ℓ 3. Next, let k be the smallest integer that is not in I. We proceed to construct a superset S′ of S and argue that S′ still fails to activate the whole graph. The set S′ is constructed as follows: • Any nodes that are in S are also in S′. • The root R is in S′. • Any tail or blocker nodes that are in the first (k − 1)-st gadgets are in S′. We argue that S′ will not activate any additional nodes in the graph. For the sake of contradiction, suppose u /∈ S′ is the first node activated when S′ is the seedset. There are two cases: Case 1. u is in the k-th gadget. The topology of the graph G ensures that any tail node vk,j cannot be activated before sk or bk. Therefore, u cannot be vk,j. One can see that min{θ(bk), θ(sk)} = θ(bk) = (k − 1)(w + 1) + 3 + ǫw. On the other hand, we only have S′ ≤ (k − 1)(w + 1) + ℓ 3 + 1. 3 ≤ ǫw so that ℓ < cn1/3 for a sufficiently small constant c, neither bk nor u is not in the k-th gadget. In this case θ(u) ≥ k(w + 1) + 3. On the other hand, S′ ≤ 3 + 1, so that when ℓ < cn1/3 for sufficiently large ℓ, the total number of active nodes is active nodes. Therefore, when ℓ sk can be active, and so we have a contradiction. Case 2. (k − 1)(w + 1) + ℓ less than θ(u), which is also a contradiction. The integrality gap. The optimal fractional solution has size O(1), while the optimal integral solution is a seedset of size Ω(ℓ) (when ℓ < cn1/3 for large enough constant c), so our integrality gap is Ω(ℓ). E.4 Remark on the role of flow constraints in reducing the integrality gap Finally, we remark the role of flow constraints in reducing the integrality gap from O(n) to O(ℓ). From the two gap instances we presented, we can see that there are two types of "bad" mass that can adversarially impact the quality of the linear program: 1. The recirculation of "fake" mass, as discussed in the pathological example of Section 3.2.1. We used recirculation of mass to construct the gap instance for the simple IP of Figure 1 in Appendix E.3.1. 2. A chain of fractional mass. Recall that both our gap instances (Appendix E.3.1 and Appendix E.3.2), used a seed candidate si to connect to a set of w = 1/ǫ tail nodes vi,1, ..., vi,w so that when an ǫ- portion of si becomes active, the total active fractional mass is ǫ · (w + 1) > 1. Meanwhile, in the integral solution, we need to activate at least one seed to have a full unit of active mass, which creates a gap of size 1/ǫ. 32 Table 3: Matrix M, the fractional assignments for a block 3 3 bi vi,1 vi,2 ... vi,ℓ vi,ℓ+1 vi,ℓ+2 ... vi,2ℓ ... vi,w−ℓ+1 vi,w−ℓ+2 ... vi,w First cycle 0 0 0 0 ǫ ǫ ǫ ... 0 0 0 0 0 0 0 0 0 0 0 0 0 . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 0 0 0 0 0 0 0 0 0 0 0 ǫ ǫ ... ǫ 0 0 ... 0 ... 0 0 ... 0 0 0 0 ... 0 0 0 ... 0 ǫ ǫ ... ǫ 1 0 0 ... 0 0 0 ... 0 ... 0 0 ... 0 0 ǫ ǫ ... ǫ 0 0 ... 0 ... 0 0 ... 0 Second cycle 0 0 0 0 0 0 . . . . . . . . . 0 0 0 . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 0 ǫ ǫ ǫ ... 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 Third cycle 0 ǫ ǫ ... ǫ 0 0 ... 0 ... 0 0 ... 0 0 0 0 0 ǫ ǫ ǫ ... 0 0 0 0 0 0 0 0 0 0 0 0 0 . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 0 0 0 0 0 0 0 0 0 0 0 0 0 ... 0 0 0 ... 0 ǫ ǫ ... ǫ 0 0 0 ... 0 0 0 ... 0 ǫ ǫ ... ǫ ... . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . w ℓ -th cycle 0 0 0 . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 ... 0 0 0 ... 0 ǫ ǫ ... ǫ 0 ǫ ǫ ... ǫ 0 0 ... 0 ... 0 0 ... 0 0 0 0 0 ǫ ǫ ǫ ... 0 0 0 The flow constraints eliminate "bad" mass of the first type (see Section 3.2.2), but cannot eliminate the second type. It turns out that if we only have the second type of "bad" mass, the integrality gap becomes O(ℓ) instead of O(n). For ease of exposition, we explain the relationship between the gap and ℓ by refering to the problem instance presented in Appendix E.3.2. These arguments can also be generalized to other problem instances. Our crucial observation is that the blockers in each of the gadgets have different thresholds. To see why, suppose that two or more gadgets had blockers that did share the same threshold. Observe that if we add a seed candidate from one of these gadgets to the seedset, all the nodes in all these gadgets will become active (because the blockers all have the same threshold). This means that we need to include fewer nodes in seedset for the optimal integral solution, which reduces the size of the integrality gap. To sum up, the idea behind our gap instance is to to pad k parallel gadgets together to get a gap of size Θ(k); for this padding to work we need at least Θ(k) different threshold values, and so the granularity of the threshold function ℓ scales linearly with the integrality gap. F Supplement: Our problem is neither submodular nor supermodular We wondered about the relationship between the algorithmic properties of our model and the linear threshold model on social networks articulated in [37]. [11] showed that the problem of selecting an op- timal seedset in the linear threshold mode in social networks cannot be approximated within a factor of O(2log1−ǫ V ) when the thresholds are deterministic and known to the algorithm. [37] got around this lower bound by assuming that nodes' thresholds are chosen uniformly at random after the seedset is selected, and designing an algorithm that chooses the optimal seedset in expectation. Their (1 − 1/e − ǫ)-approximation algorithm relies on the submodularity of the influence function, i.e., the function f (S) which gives the expected number of nodes that activate given that nodes in S are active. In this section, we shall show that algorithmic results for submodular and/or supermodular optimization do not directly apply to our problem, even if we restrict ourselves to (a) graphs of constant diameter, (b) diffusion problems with a small number of fixed thresholds, or if (c) we choose the thresholds uniformly at random as in [37]. Moreover, we see neither diminishing, nor increasing marginal returns even if we restrict ourselves to (d) connected seedsets. F.1 Fixed threshold case In this section, we construct two families of technology diffusion instances where the threshold func- tion θ is given as input. Each family will be on a graph of diameter at most 4, and require at most 2 different threshold values, and each will consider connected seedsets. The first family will fail to exhibit the submodularity property while the second will fail to exhibit supermodularity. Let {G, θ} be an arbitrary technology diffusion problem. We shall write fG,θ(S) be the total number of nodes that eventually activate after seedset S activates. When G and θ are clear from the context, we simply refer to fG,θ(S) as f (S). F.1.1 The influence function is not submodular. Let n be a sufficiently large integer such that the number of nodes in the graph is 2n + 1. This family of technology diffusion problems (which again is implicitly parameterized by n) is shown in Figure 8 and defined as follows: • The node set is {v1, v2, ..., v2n+1}. • The edge set is constructed as follows, -- The subsets {v1, ..., vn} and {vn+1, ..., v2n} form two cliques. -- Node v2n+1 is connected to all other nodes in the graph, i.e., edges {v1, v2n+1}, ..., {v2n, v2n+1}. • The threshold function is 34 v 1 v n+1 v n v 2 v 2n v n+2 v 2n+1 =n+2 2n+1 =2n+1 =n+2 Figure 8: An instance of the technology diffusion problem. This is for deterministic thresholds proof of not sub modularity v n-3 v n-1 v n-2 v n =2 =n Figure 9: Another instance of the technology diffusion problem. First sup example -- for i ≤ 2n, θ(vi) = n + 2. -- θ(v2n+1) = 2n + 1. To show this problem is non-submodular, we shall find two disjoint sets S1 and S2 such that f (S1) + f (S2) < f (S1 ∪ S2) (10) We chose S1 = {v1, ..., vn} and S2 = {v2n+1}. Note that S1 and S2 are connected, and that f (S1) = n, f (S2) = 1, while f (S1 ∪ S2) = 2n + 1 so that (10) holds. F.1.2 The influence function is not supermodular. Let n be a sufficiently large integer that represents the number of nodes in the graph. Our family of technology diffusion problems G, θ (implicitly parameterized by n) shown in Figure 9 and defined as follows: • The node set is {v1, ..., vn}. • The edge set is defined as follows: -- For any 1 ≤ i < j ≤ n−4, {vi, vj} is in the edge set, i.e., the subgraph induced by {v1, ..., vn−4} is a complete graph. -- The remaining edges are {v1, vn−3}, {v1, vn−2}, {vn−3, vn−1}, {vn−2, vn}, and {vn−3, vn−2}. • The threshold function is -- For i ≤ n − 4, θ(vi) = 2. -- For i > n − 4, θ(vi) = n. To show this problem is not supermodular, we choose two disjoint sets S1 and S2 such that f (S1) + f (S2) > f (S1 ∪ S2) (11) 35 We choose S1 = {vn−3} and S2 = {vn−2}. Note that S1 and S2 are connected, and f (S1) = f (S2) = n−3, while f (S1 ∪ S2) = n − 2 so that (11) indeed holds. F.2 Randomized threshold case We now consider a modified version of our problem, where, as in [37], we assume that thresholds are chosen uniformly at random: Definition F.1 (Randomized technology diffusion optimization problem.). The randomized technology dif- fusion model is as before, with the exception that nodes choose their thresholds uniformly and independently at random from the set {2, 3, ..., n}. Thus, the randomized technology diffusion optimization problem is to find the smallest feasible seedset S in expectation over the choice of thresholds, when G is given as input. We follow [37] and let the influence function fG(S) be the expected number of nodes that are eventually activated, i.e., fG(S) = Eθ[fG,θ(S)], where fG,θ(S) is the number of activated nodes, and expectation is taken over the choice of thresholds. We present two families of problem instances: each family will be on a graph of diameter at most 4, and will consider connected seedsets. The first family will fail to exhibit submodularity of fG(S), while the second will fail to exhibit supermodularity. F.2.1 The influence function is not submodular. Let n be a sufficiently large integer such that the number of nodes in the network is 2n + 1. Our family of G (parameterized by n) is defined as • The node set is {v1, v2, ..., v2n+1}. • The edge set is constructed as follows, -- The subsets {v1, ..., vn} and {vn+1, ..., v2n} form two cliques. -- The remaining edges are {v2n+1, v1} and {v2n+1, v2n}. Notice that this family of graphs is almost identical to the non-submodular example presented in the previous section, shown in Figure 8, except that now, the middle node v2n+1 is only connected to v1 and v2n. We shall find two disjoint set S1 and S2 such that fG(S1) + fG(S2) < fG(S1 ∪ S2). (12) Our choice of S1 and S2 is S1 = {v1, ..., vn} and S2 = {v2n+1}. We start with computing fG(S1): fG(S1) = E[fG,θ(S1) θ(v2n+1) ≤ n+1] Pr[θ(v2n+1) ≤ n+1]+E[fG,θ(S1) θ(v2n+1) > n+1] Pr[θ(v2n+1) > n+1] (13) Notice that E[fG,θ(S1) θ(v2n+1) ≤ n + 1] = E[fG,θ(S1 ∪ S2)] = fG(S1 ∪ S2) E[fG,θ(S1) θ(v2n+1) > n + 1] = n (14) Therefore, we may rewrite (13) as fG(S1) = fG(S1 ∪ S2) Pr[θ(v2n+1) ≤ n + 1] + n Pr[θ(v2n+1) > n + 1] = fG(S1 ∪ S2) 2 + n 2 . (15) We next move to compute fG(S2). To understand how the influence of S2 = {v2n+1} spreads, we condition on the thresholds of its neighbors: θ(v1), θ(v2n). fG(S2) ≤ 1 · Pr[θ(v1) > 2 ∩ θ(v2n) > 2] + (2n + 1) · Pr[θ(v1) = 2 ∪ θ(v2n) = 2] = 1(1 − 1 = 1 + 2n 1 2n )(1 − 1 2n (2(1 − 1 2n ) + (2n + 1)(2 1 2n ) + 1 2n ) ≤ 3 2n (1 − 1 2n ) + 1 2n 1 2n ) (16) 36 Therefore, from (15) and (16) we have fG(S1) + fG(S2) ≤ 3 + 1 2 (fG(S1 ∪ S2) + n) (17) Recall that our goal is to show that fG(S1) + fG(S2) < fG(S1 ∪ S2). Using (17), we now see that it suffices to prove that We prove this by conditioning on the event that S1 ∪ S2 activates node v2n: fG(S1 ∪ S2) > n + 6 fG(S1 ∪ S2) = fG(S1 ∪ S2 ∪ {v2n}) Pr[θ(v2n) ≤ n + 2] + (n + 1) Pr[θ(v2n) > n + 2] ≥ (n + 2 + n−1 = n + 1 + n+1 4 2n 2 ) n+1 2n + (n + 1) n−1 where the first inequality follows because the thresholds of half of the nonseed nodes {vn+1, ..., v2n−1} are ≤ n + 1 in expectation. Thus, we indeed have that S1 and S2 are connected and fG(S1) + fG(S2) < fG(S1 ∪ S2) when n is sufficiently large. F.2.2 The influence function is not supermodular. Let n be a sufficiently large integer such that the number of nodes in the network is 2n + 1. Our family of graphs (parameterized by n) is defined as follows, • The node set is {v1, v2, ..., v2n+1}. • The edge set is constructed as follows, -- The subsets {v1, ..., vn} and {vn+1, ..., v2n} form two cliques. -- Node v2n+1 is connected to all other nodes in the graph. -- There is an additional edge {v1, v2n}. Notice that this family of graphs is almost identical to the one shown in Figure 8, except for the addition of a single edge {v1, v2n}. We shall find two disjoint set S1 and S2 such that fG(S1) + fG(S2) > fG(S1 ∪ S2). (18) Our choice of S1 and S2 is S1 = {v1, ..., vn} and S2 = {vn+1, ..., v2n}. Notice that these sets are connected by the edge {v1, v2n}. By symmetry we have that f (S1) = f (S2), so we start by computing fG(S1). Let T be the number of active nodes in S2, and let A be the event that node v2n+1 is active. E[fG,θ(S1)] ≥ n + (1 + E[T A, S1 active]) Pr[AS1 active] 2n ) n ≥ n + (1 + n · n+1 2 (1 + n+1 = n + 1 4 ) 2n (19) where the second inequality follows because we used the trivial bound E[T A, S1 active] ≥ n n+1 2n where we ignore all cascading effects; we simply assume that each of the n nodes in S2 is connected to an active component of size n + 1. On the other hand, E[fG,θ(S1 ∪ S2)] ≤ 2n + 1 (20) Thus we indeed have fG(S1) + f (S2) ≥ 2n + 1 + n+1 4 > 2n + 1 = fG(S1 ∪ S2) for all n. 37 B A F D C E Threshold function A connected activation sequence θ(A) = 5 θ(B) = 2 θ(C) = 3 θ(D) = 5 θ(E) = 4 θ(F ) = 6 xA,1 = 1, (∀t 6= 1, xA,t = 0) xB,2 = 1, (∀t 6= 2, xB,t = 0) xC,3 = 1, (∀t 6= 3, xB,t = 0) xD,5 = 1, (∀t 6= 5, xB,t = 0) xE,6 = 1, (∀t 6= 6, xB,t = 0) xF,4 = 1, (∀t 6= 4, xB,t = 0) Figure 10: A problem instance and a feasible connected activation sequence. G Supplement:Expository examples and figures We now present examples of the constructions we used in Section 2 and Section 3. We start with the problem instance {G, θ} in Figure 10, and present a feasible connected activation sequence T for this problem instance. This feasible connected activation sequence T uniquely corresponds to the seedset S = {A, D}, since these are the only nodes that have T (u) < θ(u). The flow graph H used for the relaxed linear program is shown in Figure 11. The solid line is the threshold line. The (solid and dotted) trajectories represent some paths that can be used to push some amount of flow f ∈ [0, 1] between the nodes in H (i.e., so that the flow constraints are satisfied). Notice that every trajectory in H corresponds to an edge in the original graph G. Let us consider the (E, 6)-flow problem. The solid trajectories in Figure 11 illustrate a feasible flow to solve the problem, which we use as the representative flow FE,6. Notice that (E, 6)-flow has demand from two nodes (E, 5) and (E, 6) and thus FE,6 has two sinks. We decompose FE,6 into two paths P1 = (A, 1), (C, 3), (F, 4), (E, 5) and P2 = (A, 1), (B, 5), (E, 6). The border node for path P1 is border(P) = (F, 4) and the border node for path P2 is border(P) = (A, 1). Thus, β(E, 6) = {(A, 1), (F, 4)} and B(E, 6) = {A, F }. As an example of GET-SEQ, suppose that the seedset is S = {A, C, F } (note that S is connected), and refer to the graph in Figure 10. First, we would "activate" vertices in H that correspond to seedset nodes, namely XA,1, ..., XA,6, and XC,1, ..., XC,6, and XF,1, ..., XF,6. Next, we iterate over each of the timesteps. At t = 2, since the {A, B} ∈ E(G) and thus (XA,1, XB,2) is in E(H), we may activate XB,2 as well as all XB,t for all t > 2. At time t = 3, we do not find any new nodes that can be activated. Similarly, at time t = 4, we can activate XE,4-XE,6 since {E, C} is an edge; at time t = 5, we can activate XD,5-XD,6. Finally at t = 6, all nodes are activated and nothing needs to be done at this step. So we finally obtain the activation sequence: T = ({A, C, F }, {B}, ⊥, {E}, {D}, ⊥). 38 Figure12: Therepresentativeflow in -flowproblemandthecorresponding bordernodes. ThresholdLine A, 1) A, 2) A, 3) A, 4) A, 5) A, 6) B, 1) B, 2) B, 3) B, 4) B, 5) B, 6) C, 1) C, 2) C, 3) C, 4) C, 5) C, 6) D, 1) D, 2) D, 3) D, 4) D, 5) D, 6) E, 1) E, 2) E, 3) E, 4) E, 5) E, 6) F, 1) F, 2) F, 3) F, 4) F, 5) F, 6) Figure13: Therepresentativeflow Figure 11: The in graph and the trajectories of flows. -flowproblemandthecorresponding bordernodes. 40 Threshold Line (A, 1) (A, 2) (A, 3) (A, 4) (A, 5) (A, 6) (B, 1) (B, 2) (B, 3) (B, 4) (B, 5) (B, 6) (C, 1) (C, 2) (C, 3) (C, 4) (C, 5) (C, 6) (D, 1) (D, 2) (D, 3) (D, 4) (D, 5) (D, 6) (E, 1) (E, 2) (E, 3) (E, 4) (E, 5) (E, 6) (F, 1) (F, 2) (F, 3) (F, 4) (F, 5) (F, 6) Figure 11: The H graph and the trajectories of flows. Figure 12: ADD TITLE HERE. 39 39
1204.3114
4
1204
2013-02-07T20:40:20
On the Role of Mobility for Multi-message Gossip
[ "cs.SI", "cs.IT", "cs.NI", "cs.IT" ]
We consider information dissemination in a large $n$-user wireless network in which $k$ users wish to share a unique message with all other users. Each of the $n$ users only has knowledge of its own contents and state information; this corresponds to a one-sided push-only scenario. The goal is to disseminate all messages efficiently, hopefully achieving an order-optimal spreading rate over unicast wireless random networks. First, we show that a random-push strategy -- where a user sends its own or a received packet at random -- is order-wise suboptimal in a random geometric graph: specifically, $\Omega(\sqrt{n})$ times slower than optimal spreading. It is known that this gap can be closed if each user has "full" mobility, since this effectively creates a complete graph. We instead consider velocity-constrained mobility where at each time slot the user moves locally using a discrete random walk with velocity $v(n)$ that is much lower than full mobility. We propose a simple two-stage dissemination strategy that alternates between individual message flooding ("self promotion") and random gossiping. We prove that this scheme achieves a close to optimal spreading rate (within only a logarithmic gap) as long as the velocity is at least $v(n)=\omega(\sqrt{\log n/k})$. The key insight is that the mixing property introduced by the partial mobility helps users to spread in space within a relatively short period compared to the optimal spreading time, which macroscopically mimics message dissemination over a complete graph.
cs.SI
cs
On the Role of Mobility for Multi-message Gossip Yuxin Chen, Sanjay Shakkottai and Jeffrey G. Andrews 1 3 1 0 2 b e F 7 ] I S . s c [ 4 v 4 1 1 3 . 4 0 2 1 : v i X r a Abstract -- We consider information dissemination in a large n-user wireless network in which k users wish to share a unique message with all other users. Each of the n users only has knowledge of its own contents and state information; this corresponds to a one-sided push-only scenario. The goal is to disseminate all messages efficiently, hopefully achieving an order- optimal spreading rate over unicast wireless random networks. First, we show that a random-push strategy -- where a user √ sends its own or a received packet at random -- is order-wise suboptimal in a random geometric graph: specifically, Ω ( n) times slower than optimal spreading. It is known that this gap can be closed if each user has "full" mobility, since this effectively creates a complete graph. We instead consider velocity- constrained mobility where at each time slot the user moves locally using a discrete random walk with velocity v(n) that is much lower than full mobility. We propose a simple two- stage dissemination strategy that alternates between individual message flooding ("self promotion") and random gossiping. We prove that this scheme achieves a close to optimal spreading rate (within only a logarithmic gap) as long as the velocity is at least v(n) = ω((cid:112)log n/k). The key insight is that the mixing property introduced by the partial mobility helps users to spread in space within a relatively short period compared to the optimal spreading time, which macroscopically mimics message dissemination over a complete graph. Index Terms -- Gossip algorithms, information dissemination, mobility, wireless random networks I. INTRODUCTION In wireless ad hoc or social networks, a variety of sce- narios require agents to share their individual information or resources with each other for mutual benefits. A partial list includes file sharing and rumor spreading [2] -- [5], distributed computation and parameter estimation [6] -- [10], and schedul- ing and control [11], [12]. Due to the huge centralization overhead and unpredictable dynamics in large networks, it is usually more practical to disseminate information and ex- change messages in a decentralized and asynchronous manner to combat unpredictable topology changes and the lack of global state information. This motivates the exploration of dissemination strategies that are inherently simple, distributed and asynchronous while achieving optimal spreading rates. Y. Chen is with the Department of Electrical Engineering and the De- partment of Statistics, Stanford University, Stanford CA 94305, USA (email: [email protected]). S. Shakkottai is with the Department of Electrical and Computer Engineering, the University of Texas at Austin, Austin TX 78712, USA (email: [email protected]). J. G. Andrews is with the Department of Electrical and Computer Engineering, the University of Texas at Austin, Austin TX 78712, USA (email: [email protected]). The contact author is S. Shakkottai. This research has been supported by the DARPA Information Theory for Mobile Ad Hoc Networks (IT-MANET) program and NSF Grant 0721380. It has been presented in part at the IEEE Infocom 2011 [1]. Manuscript date: September 15, 2018. A. Motivation and Related Work Among distributed asynchronous algorithms, gossip algo- rithms are a class of protocols which propagate messages according to rumor-style rules, initially proposed in [13]. Specifically, suppose that there are k ≤ n distinct pieces of messages that need to be flooded to all n users in the network. Each agent in each round attempts to communicate with one of its neighbors in a random fashion to disseminate a limited number of messages. There are two types of push- based strategies on selecting which message to be sent in each round: (a) one-sided protocols that are based only on the disseminator's own current state; and (b) two-sided protocols based on current states of both the sender and the receiver. Encouragingly, a simple uncoded one-sided push-only gossip algorithm with random message selection and peer selection is sufficient for efficient dissemination in some cases like a static complete graph, which achieves a spreading time of Θ (k log n) 1, within only a logarithmic gap with respect to the optimal lower limit Θ(k) [14] -- [16]. This type of one-sided gossiping has the advantages of being easily implementable and inherently distributed. Since each user can receive at most one message in any single slot, it is desirable for a protocol to achieve close to the fastest possible spreading time Θ (k) (e.g. within a polylog(n) factor). It has been pointed out, however, that the spreading rate of one-sided random gossip algorithms is frequently constrained by the network geometry, e.g. the conductance of the graph [15], [17]. For instance, for one-sided rumor-style all-to-all spreading (i.e. k = n), the completion time T is much lower in a complete graph (T = O (n log n)) than in a ring (cid:0)T = Ω(n2)(cid:1). Intuitively, since each user can only communicate with its nearest neighbors, the geometric constraints in these graphs limit the location distribution of all copies of each message during the evolution process, which largely limits how fast the information can flow across the network. In fact, for message spreading over static wireless networks, one-sided uncoded push-based random gossiping can be quite inefficient: specifically up to Ω times slower than the optimal lower limit Θ (k) (i.e. a poly- nomial factor away from the lower bound), as will be shown in Theorem 2. (cid:18)(cid:113) n poly(log n) (cid:19) Although one-sided random gossiping is not efficient for static wireless networks, it may potentially achieve better performance if each user has some degree of mobility -- an intrinsic feature of many wireless and social networks. For 1The standard notion f (n) = ω (g(n)) means n→∞g(n)/f (n) = 0; lim n→∞f (n)/g(n) = 0; f (n) = Ω (g(n)) means ∃ f (n) = o (g(n)) means a constant c such that f (n) ≥ cg(n); f (n) = O (g(n)) means ∃ a constant c such that f (n) ≤ cg(n); f (n) = Θ (g(n)) means ∃ constants c1 and c2 such that c1g(n) ≤ f (n) ≤ c2g(n). lim (cid:18)(cid:113) log n (cid:19) n instance, full mobility2 changes the geometric graph with transmission range O to a complete graph in the unicast scenario. Since random gossiping achieves a spreading time of Θ (nlog(n)) for all-to-all spreading over a complete graph [15], [16], this allows near-optimal spreading time to be achieved within a logarithmic factor from the fundamental lower limit Θ (n). However, how much benefit can be obtained from more realistic mobility -- which may be significantly lower than idealized best-case full mobility -- is not clear. Most existing results on uncoded random gossiping center on evolutions associated with static homogeneous graph structure or a fixed adjacency matrix, which cannot be readily extended for dynamic topology changes. To the best of our knowledge, the first work to analyze gossiping with mobility was [18], which focused on energy-efficient distributed averaging instead of time-efficient message propagation. Another line of work by Clementi et. al. investigate the speed limit for information flooding over Markovian evolving graphs (e.g. [19] -- [21]), but they did not study the spreading rate under multi-message gossip. Recently, Pettarin et. al. [22] explored the information spreading over sparse mobile networks with no connected components of size Ω (log n), which does not account for the dense (interference-limited) network model we consider in this paper. For a broad class of graphs that include both static and dynamic graphs, the lower limit on the spreading time can be achieved through random linear coding where a random combination of all messages are transmitted instead of a specific message [23], or by employing a two-sided protocol which always disseminates an innovative message if possible [16]. Specifically, through a unified framework based on dual- space analysis, recent work [24] demonstrated that the optimal all-to-all spreading time Θ(n) can be achieved for a large class of graphs [24] including complete graphs, geometric graphs, and the results hold in these network models even when the topology is allowed to change dynamically at each time. However, performing random network coding incurs very large computation overhead for each user, and is not always feasible in practice. On the other hand, two-sided protocols inherently require additional feedback that increases commu- nication overhead. Also, the state information of the target may sometimes be unobtainable due to privacy or security concerns. n messages that need to be disseminated over a static uncoordinated unicast wireless network or a random geometric graph with transmission radius , neither network coding nor two-sided Θ protocols can approach the lower limit of spreading time Θ(k). This arises due to the fact that the diameter of the underlying graph with transmission range Θ Furthermore, if there are k (cid:28) √ (cid:16)(cid:113) 1 (cid:18)(cid:113) poly(log n) npoly (log n) (cid:19) (cid:17) n scales as Ω poly(log n) , and hence each message may need (cid:18)(cid:113) n (cid:19) 2By full mobility, we mean that the location of the mobile is distributed independently and uniformly random over the entire network over consecutive time-steps (i.e., the velocity of the mobile can be "arbitrarily large"). This is sometimes also referred to in literature as the i.i.d. mobility model. In this paper, we consider nodes with "velocity-limited" mobility capability. (cid:18)(cid:113) n to be relayed through Ω the node farthest to the source. poly(log n) (cid:19) 2 hops in order to reach Another line of work has studied spreading scaling laws using more sophisticated non-gossip schemes over static wire- less networks, e.g. [25], [26]. Recently, Resta et. al. [27] began investigating broadcast schemes for mobile networks with a single static source constantly propagating new data, while we focus on a different problem with multiple mobile sources each sharing distinct message. Besides, [27] analyzed how to combat the adverse effect of mobility to ensure the same pipelined broadcasting as in static networks, whereas we are interested in how to take advantage of mobility to overcome the geometric constraints. In fact, with the help of mobility, simply performing random gossiping -- which is simpler than most non-gossip schemes and does not require additional overhead -- is sufficient to achieve optimality. Finally, we note that gossip algorithms have also been employed and analyzed for other scenarios like distributed av- eraging, where each node is willing to compute the average of all initial values given at all nodes in a decentralized manner, e.g. [6], [8]. The objective of such distributed consensus is to minimize the total number of computations. It turns out that the convergence rates of both message sharing and distributed averaging are largely dependent on the eigenvalues or, more specifically, the mixing times of the graph matrices associated with the network geometry [8], [15]. B. Problem Definition and Main Modeling Assumptions Suppose there are n users randomly located over a square of unit area. The task is to disseminate k ≤ n distinct messages (each contained in one user initially) among all users. The message spreading can be categorized into two types: (a) single-message dissemination: a single user (or Θ(1) users) wishes to flood its message to all other users; (b) multi- message dissemination: a large number k(k (cid:29) 1) of users wish to spread individual messages to all other users. We note that distinct messages may not be injected into the network simultaneously. They may arrive in the network (possibly in batches) sequentially, but the arrival time information is unknown in the network. Our objective is to design a gossip-style one-sided algorithm in the absence of coding, such that it can take advantage of the intrinsic feature of mobility to accelerate dissemination. Only the "push" operation is considered in this paper, i.e. a sender determines which message to transmit solely based on its own current state, and in particular not using the intended receiver's state. We are interested in identifying the range of the degree of mobility within which our algorithm achieves near-optimal spreading time O (k poly (log n)) for each message regardless of message arrival patterns. Specifically, our MOBILE PUSH protocol achieves a spreading time O(cid:0)k log2 n(cid:1) as stated in Theorem 3 for the mobility that is significantly lower than the idealized full mobility. As an aside, it has been shown in [16], [23] that with high probability, the completion time for one- sided uncoded random gossip protocol over complete graphs is lower bounded by Ω (k log n), which implies that in general Table I SUMMARY OF NOTATION v(n) m n k Mi Ak Ni(t),Ni(t) Ni,Ak (t),Ni,Ak (t) Si(t), Si(t) α β velocity the number of subsquares; m = 1/v2(n) the number of users/nodes the number of distinct messages the message of source i subsquare k the number, and the set of nodes containing Mi at time t the number, and the set of nodes containing Mi at subsquare Ak at time t the number, and the set of messages node i has at time t path loss exponent SINR requirement for single-hop success 3 subsquare is selected uniformly at random. See Fig. 1 for an illustration. We note that when v(n) = 1/3 = Θ(1), the pattern reverts to the full mobility model. In this random-walk model, each node moves independently according to a uniform ergodic distribution. In fact, a variety of mobility patterns have been proposed to model mobile networks, including i.i.d. (full) mobility [29], random walk (discrete-time) model [30], [31], and Brownian motion (continuous-time) pattern [32]. For simplicity, we model it as a discrete-time random walk pattern, since it already captures intrinsic features of mobile networks like uncontrolled placement and movement of nodes. the logarithmic gap from the universal lower limit Θ (k) cannot be closed with uncoded one-sided random gossiping. Our basic network model is as follows. Initially, there are n users uniformly distributed over a unit square. We ignore edge effects so that every node can be viewed as homogeneous. Our models and analysis are mainly based on the context of wireless ad hoc networks, but one can easily apply them to other network scenarios that can be modeled as a random geometric graph of transmission radius Θ (cid:16)(cid:112)log n/n (cid:17) . Physical-Layer Transmission Model. Each transmitter em- ploys the same amount of power P , and the noise power density is assumed to be η. The path-loss model is used such that node j receives the signal from transmitter i with power P r−α ij , where rij denotes the Euclidean distance between i and j with α > 2 being the path loss exponent. Denote by T (t) the set of transmitters at time t. We assume that a packet from transmitter i is successfully received by node j at time t if SINRij(t) : = η + (cid:80) P r−α ij ≥ β, P r−α kj (1) k(cid:54)=i,k∈T (t) where SINRij(t) is the signal-to-interference-plus-noise ratio (SINR) at j at time t, and β the SINR threshold required for successful reception. For simplicity, we suppose only one fixed-size message or packet can be transmitted for each transmission pair in each time instance. Suppose that each node can move with velocity v(n) in this mobile network. We provide a precise description of the mobility pattern as follows. √ Mobility Model. We use a mobility pattern similar to [28, Section VIII], which ensures that at steady state, each user lies in each subsquare with equal probability. Specifically, we divide the entire square into m := 1/v2(n) subsquares each of area v2(n) (where v(n) denotes the velocity of the mobile m discrete torus. At each time nodes), which forms a √ m×√ instance, every node moves according to a random walk on the m discrete torus. More precisely, if a node resides in a subsquare (i, j) ∈ {1,··· , m}2 at time t, it may choose to stay in (i, j) or move to any of the eight adjacent subsquares each with probability 1/9 at time t + 1. If a node is on the edge and is selected to move in an infeasible direction, then it stays in its current subsquare. The position inside the new m×√ √ Figure 1. The unit square is equally divided into m = 1/v2(n) subsquares. Each node can jump to one of its 8 neighboring subsquares or stay in its current subsquare with equal probability 1/9 at the beginning of each slot. C. Contributions and Organization The main contributions of this paper include the following. 1) Single-message dissemination over mobile networks. We derive an upper bound on the single-message (k = Θ (1)) spreading time using push-only random gossiping (called RANDOM PUSH) in mobile networks. A gain n/ log2 n)(cid:1) in the spreading rate can be ob- of Ω(cid:0)v(n) √ tained compared with static networks, which is, however, still limited by the underlying geometry unless there is full mobility. (cid:17) (cid:16) √ 2) Multi-message dissemination over static networks. We develop a lower bound on the multi-message spread- ing time under RANDOM PUSH protocol over static networks. It turns out that there may exist a gap as large between its spreading time and the as Ω optimal lower limit Θ (k). The key intuition is that the copies of each message Mi tend to cluster around the source i at all time instances, which results in capacity loss. This inherently constrains how fast the information can flow across the network. poly(log n) n )( size of subsquare2nvedges )(/1nvm= 3) Multi-message dissemination over mobile networks. We design a one-sided uncoded message-selection strat- egy called MOBILE PUSH that accelerates multi- message spreading (k = ω (log n)) with mobility. An upper bound on the spreading time is derived, which is the main result of this paper. Once v(n) = ω (which is still significantly smaller than full mobility), (cid:19) (cid:18)(cid:113) log n the near-optimal spreading time O(cid:0)k log2 n(cid:1) can be k achieved with high probability. The underlying intuition is that if the mixing time arising from the mobility model is smaller than the optimal spreading time, the mixing property approximately uniformizes the location of all copies of each message, which allows the evolution to mimic the propagation over a complete graph. The remainder of this paper is organized as follows. In Section II, we describe our unicast physical-layer transmission strat- egy and two types of message selection strategies, including RANDOM PUSH and MOBILE PUSH. Our main theorems are stated in Section II as well, with proof ideas illustrated in Section 3. Detailed derivation of auxiliary lemmas are deferred to the Appendix. II. STRATEGIES AND MAIN RESULTS The strategies and main results of this work are outlined in this section, where only the unicast scenario is considered. The dissemination protocols for wireless networks are a class of scheduling algorithms that can be decoupled into (a) physical- layer transmission strategies (link scheduling) and (b) message selection strategies (message scheduling). One physical-layer transmission strategy and two message selection strategies are described separately, along with the order-wise performance bounds. A. Strategies 1) Physical-Layer Transmission Strategy: to achieve efficient spreading, it is natural to resort to a decentral- ized transmission strategy that supports the order-wise largest number (i.e. Θ(n)) of concurrent successful transmissions per time instance. The following strategy is a candidate that achieves this objective with local communication. In order UNICAST Physical-Layer Transmission Strategy: • At each time slot, each node i is designated as a sender independently with constant probability θ, and a potential receiver otherwise. Here, θ < 0.5 is independent of n and k. • Every sender i attempts to transmit one message to its nearest potential receiver j(i). This simple "link" scheduling strategy, when combined with appropriate push-based message selection strategies, leads to the near-optimal performance in this paper. We note that the authors in [29], by adopting a slightly different strategy in which θn nodes are randomly designated as senders (as opposed to link-by-link random selection as in our paper), have shown that the success probability for each unicast pair is a constant. Using the same proof as for [29, Theorem III-5], we can see (which we omit here) that there exists a constant c such that P(cid:0)SINRi,j(i)(t) > β(cid:1) ≥ c 4 (2) holds for our strategy. Here, c is a constant irrespective of n, but may depend on other salient parameters P , α and η. That said, Θ (n) concurrent transmissions can be successful, which is order-optimal. For ease of analysis and exposition, we fur- ther assume that physical-layer success events are temporally independent for simplicity of analysis and exposition. Indeed, even accounting for the correlation yields the same scaling results, detailed in Remark 1. Remark 1. In fact, the physical-layer success events are correlated across different time slots due to our mobility model and transmission strategy. However, we observe that our analysis framework would only require that the transmis- sion success probability at time t + 1 is always a constant irrespective of n given the node locations at time t. To address this concern, we show in Lemma 1 that for any m < n/ (32 log n), the number of nodes NAi residing in each least 1− 2n−3. Conditional on this high-probability event that (cid:3) with probability at subsquare Ai is bounded within(cid:2) n NAi ∈(cid:2) n (cid:3) with all nodes in each subsquare uniformly show that P(cid:0)SINRi,j(i)(t) > β(cid:1) ≥ c holds for some constant located, we can use the same proof as [29, Theorem III-5] to 6m , 7n 6m , 7n 3m 3m c. local transmissions, Although this physical-layer transmission strategy supports Θ (n) concurrent tell us how to take advantage of these resources to allow efficient propagation. This will be specified by the message-selection strategy, which potentially determines how each message is propagated and forwarded over the entire network. it does not 2) Message Selection Strategy: We now turn to the ob- jective of designing a one-sided message-selection strategy (only based on the transmitter's current state) that is efficient in the absence of network coding. We are interested in a decentralized strategy in which no user has prior information on the number of distinct messages existing in the network. One common strategy within this class is: RANDOM PUSH Message Selection Strategy: • In every time slot: each sender i randomly selects one of the messages it possesses for transmission. This is a simple gossip algorithm solely based on random message selection, which is surprisingly efficient in many cases like a complete graph. It will be shown later, however, that this simple strategy is inefficient in a static unicast wire- less network or a random geometric graph with transmission range Θ (cid:18)(cid:113) log n (cid:19) . n In order to take advantage of the mobility, we propose the following alternating strategy within this class: MOBILE PUSH Message Selection Strategy: • Denote by Mi the message that source i wants to spread, i.e. its own message. • In every odd time slot: for each sender i, if it has an individual message Mi, then i selects Mi for transmission; otherwise i randomly selects one of the messages it possesses for transmission. • In every even time slot: each sender i randomly selects one of the messages it has received for transmission. In the above strategy, each sender alternates between ran- dom gossiping and self promotion. This alternating operation is crucial if we do not know a priori the number of distinct messages. Basically, random gossiping enables rapid spreading by taking advantage of all available throughput, and provides a non-degenerate approach that ensures an approximately "uniform" evolution for all distinct messages. On the other hand, individual message flooding step plays the role of self- advocating, which guarantees that a sufficiently large number of copies of each message can be forwarded with the assistance of mobility (which is not true in static networks). This is critical at the initial stage of the evolution. B. Main Results (without proof) Now we proceed to state our main theorems, each of which characterizes the performance for one distinct scenario. Detailed analysis is deferred to Section III. 1) Single-Message Dissemination in Mobile Networks with RANDOM PUSH: The first theorem states the limited benefits of mobility on the spreading rate for single-message spreading when RANDOM PUSH is employed. We note that MOBILE PUSH reverts to RANDOM PUSH for single-message dissem- ination, and hence has the same spreading time. Theorem 1. Assume that the velocity obeys v(n) > , and that the number of distinct messages obeys k = Θ (1). RANDOM PUSH message selection strategy is assumed to be sp (i) the time employed in the unicast scenario. Denote by T uc taken for all users to receive message Mi after Mi is injected into the network, then with probability at least 1 − n−2 we have ∀i, T uc . (3) n/ log n) un- der RANDOM PUSH over static wireless networks or random geometric graphs of radius Θ [17], the gain in (cid:16)(cid:112)log n/n (cid:17) dissemination rate due to mobility is Ω(cid:0)v(n) Since the single-message flooding time is Ω( sp (i) = Ω √ (cid:18) log n (cid:18) 1 sp (i) = O and T uc (cid:19) (cid:19) v(n) v(n) √ n/ log2 n)(cid:1). (cid:18)(cid:113) log n (cid:19) When the mobility is large enough (e.g. v(n) = ω ), it plays the role of increasing the transmission radius, thus resulting in the speedup. It can be easily verified, however, that the universal lower bound on the spreading time is Θ (log n), which can only be achieved in the presence of full mobility. To summarize, while the speedup Ω(cid:0)v(n) (cid:113) 32 log n n/ log2 n)(cid:1) can √ ≤ v(n) ≤ Θ(1), be achieved in the regime n n (cid:113) 32 log n n 5 RANDOM PUSH cannot achieve near-optimal spreading time O (poly (log n)) for single-message dissemination unless full mobility is present. 2) Multi-Message Dissemination in Static Networks with RANDOM PUSH: Now we turn to multi-message spreading over static networks with uncoded random gossiping. Our analysis is developed for the regime where there are k distinct messages that satisfies k = ω (polylog (n)), which subsumes most multi-spreading cases of interest. For its complement √ regime where k = O(polylog (n)), an apparent lower bound n/polylog(n)) on the spreading time can be obtained by Ω ( observing that the diameter of the underlying graph with trans- mission radius Θ n/polylog(n)). √ n/polylog(n)) between This immediately indicates a gap Ω ( the spreading time and the lower limit k = O (polylog(n)). √ is at least Ω ( (cid:18)(cid:113) log n (cid:19) n The spreading time in the regime k = ω (poly (log n)) is formally stated in Theorem 2, which implies that simple RANDOM GOSSIP is inefficient in static wireless networks, under a message injection scenario where users start message dissemination sequentially. The setting is as follows: (k − 1) of the sources inject their messages into the network at some time prior to the k-th source. At a future time when each user in the network has at least w = ω (poly (log n)) messages, the k-th message (denoted by M∗) is injected into the network. This pattern occurs, for example, when a new message is injected into the network much later than other messages, and hence all other messages have been spread to a large number of users. We will show that without mobility, the spreading time under MOBILE PUSH in these scenarios is at least of the same order as that under RANDOM PUSH 3, which is a polynomial factor away from the universal lower limit Θ(k). In fact, the individual message flooding operation of MOBILE PUSH does not accelerate spreading since each source has only O(poly (log n)) potential neighbors to communicate. The main objective of analyzing the above scenario is to uncover the fact that uncoded one-sided random gossiping fails to achieve near-optimal spreading for a large number of message injection scenarios over static networks. This is in contrast to mobile networks, where protocols like MOBILE PUSH with the assistance of mobility is robust to all ini- tial message injection patterns and can always achieve near- optimal spreading, as will be shown later. Theorem 2. Assume that a new message M∗ arrives in a static network later than other k − 1 messages, and suppose that M∗ is first injected into the network from a state such that each node has received at least w = ω (poly (log n)) distinct messages. Denote by T ∗ the time until every user receives M∗ using RANDOM PUSH, then for any constant  > 0 we have (cid:114) n 128 log n T ∗ > w1− (4) with probability exceeding 1 − n−2. 3We note that this section is devoted to showing the spreading inefficiency under two uncoded one-sided push-only protocols. It has recently been shown in [24] that a network coding approach can allow the optimal spreading time Θ(k) to be achieved over static wireless networks or random geometric graphs. (cid:16) (cid:17) (cid:16)(cid:112)log n/k (cid:17) Remark 2. Our main goal is to characterize the spreading inefficiency when each node has received a few messages, which becomes most significant when each has received Θ (k) messages. In contrast, when only a constant number of messages are available at each user, the evolution can be fairly fast since the piece selection has not yet be- come a bottleneck. Hence, we consider w = ω(polylog(n)), which captures most of regime (ω(polylog(n)) ≤ w ≤ Θ(k)). The spreading can be quite slow for various message-injection process over static net- works, but can always be completed within O(cid:0)k log2 n(cid:1) with the spreading-inefficient regardless the assistance of mobility v(n) = ω of the message-injection process, as will be shown in Theorem 3. (cid:17) (cid:16) √ Theorem 2 implies that if M∗ is injected into the network messages for any when each user contains ω  > 0, then RANDOM PUSH is unable to approach the fastest possible spreading time Θ (k). In particular, if the message is first transmitted when each user contains Ω (k/poly(log n)) messages, then at least Ω(cid:0)k1−√ n/poly(log n)(cid:1) time slots npoly(log n) k1+2 √ n poly(log n) are required to complete spreading. Since  can be arbitrarily small, there may exist a gap as large as Ω between the lower limit Θ(k) and the spreading time using RANDOM PUSH. The reason is that as each user receives many distinct messages, a bottleneck of spreading rate arises due to the low piece-selection probability assigned for each message. A number of transmissions are wasted due to the blindness of the one-sided message selection, which results in capacity loss and hence largely constrain how efficient information can flow across the network. The copies of each message tend to cluster around the source -- the density of the copies decays rapidly with the distance to the source. Such inefficiency becomes more severe as the evolution proceeds, because each user will assign an increasingly smaller piece-selection probability for each message. (cid:19) (cid:18)(cid:113) log n 3) Multi-Message Dissemination in Mobile Networks with MOBILE PUSH: Although the near-optimal spreading time O (polylog(n)) for single message dissemination can only be achieved when there is near-full mobility v(n) = Ω (1/polylog(n)), a limited degree of velocity turns out to be remarkably helpful in the multi-message case as stated in the following theorem. Theorem 3. Assume that the velocity obeys: v(n) = , where the number of distinct messages obeys ω k = ω (poly (log n)). MOBILE PUSH message selection strat- egy is employed along with unicast transmission strategy. Let mp(i) be the time taken for all users to receive message Mi T uc after Mi is first injected into the network, then with probability at least 1 − n−2 we have ∀i, T uc mp(i) = O(cid:0)k log2 n(cid:1) . (5) k Since each node can receive at most one message in each time slot, the spreading time is lower bounded by Θ (k) for any graph. Thus, our strategy with limited velocity spreads the information essentially as fast as possible. Intuitively, 6 this is due to the fact that the velocity (even with restricted magnitude) helps uniformize the locations of all copies of each message, which significantly increases the conductance of the underlying graph in each slot. Although the velocity is significantly smaller than full mobility (which simply results in a complete graph), the relatively low mixing time helps to approximately achieve the same objective of uniformization. On the other hand, the low spreading rates in static networks arise from the fact that the copies of each message tend to cluster around the source at any time instant, which decreases the number of flows going towards new users without this message. Remark 3. Note that there is a O(cid:0)log2 n(cid:1) gap between this spreading time and the lower limit Θ(k). We conjecture that Θ (k log n) is the exact order of the spreading time, where the logarithmic gap arises from the blindness of peer and piece selection. A gap of Θ (log n) was shown to be indispensable for complete graphs when one-sided random push is used [23]. Since the mobility model simply mimics the evolution in complete graphs, a logarithmic gap appears to be unavoidable when using our algorithm. Nevertheless, we conjecture that with a finer tuning of the concentration of measure techniques, the current gap O(cid:0)log2 n(cid:1) can be narrowed to Θ (log n). See Remark 5. III. PROOFS AND DISCUSSIONS OF MAIN RESULTS The proofs of Theorem 1-3 are provided in this section. Before continuing, we would like to state some preliminar- ies regarding the mixing time of a random walk on a 2- dimensional grid, some related concentration results, and a formal definition of conductance. A. Preliminaries 1) Mixing Time: Define the probability of a typical node moving to subsquare Ai at time t as πi(t) starting from any subsquare, and denote by πi the steady-state probabil- ity of a node residing in subsquare Ai. Define the mixing time of our random walk mobility model as Tmix () := min{t : πi(t) − πi ≤ ,∀i}, which characterizes the time until the underlying Markov chain is close to its stationary distribution. It is well known that the mixing time of a random walk on a grid satisfies (e.g. see [33, Corollary 2.3] and [33, Appendix C]): (cid:18) (cid:19) Tmix () ≤ cm log 1  + log n (6) for some constant c. We take  = n−10 throughout this paper, so Tmix () ≤ c0m log n holds with c0 = 10c. After c0m log n amount of time slots, all the nodes will reside in any subsquare almost uniformly likely. In fact, n−10 is very conservative and a much larger  suffices for our purpose, but this gives us a good sense of the sharpness of the mixing time order. See [34, Section 6] for detailed characterization of the mixing time of random walks on graphs. 2) Concentration Results: The following concentration re- sult is also useful for our analysis. Lemma 1. Assume that b nodes are thrown independently into m subsquares. Suppose for any subsquare Ai, the probability qAi of each node being thrown to Ai is bounded as in any subsquare Ai(1 ≤ i ≤ m < n) at any time t ∈(cid:2)1, n2(cid:3) Then for any constant , the number of nodes NAi(t) falling 3m m (7) (cid:12)(cid:12)(cid:12)(cid:12)qAi − 1 (cid:12)(cid:12)(cid:12)(cid:12) ≤ 1 . satisfies (cid:18) (cid:32) a) if b = Θ (m log n) and b > 32m log n, then P ∀(i, t) : b 6m ≤ NA(i)(t) ≤ 7b 3m ≥ 1 − 2 n3 ; b) if b = ω (m log n), then P ∀(i, t) : ≤ NA(i)(t) ≤ (cid:0) 2 3 − (cid:1) b m (cid:19) (cid:0) 4 3 + (cid:1) b m (cid:33) ≥ 1 − 2 n3 . (cid:80) Proof: See Appendix A. This implies that the number of nodes residing in each subsquare at each time of interest will be reasonably close to the true mean. This concentration result follows from standard Chernoff bounds [35, Appendix A], and forms the basis for our analysis. 3) Conductance: Conductance is an isoperimetric measure that characterizes the expansion property of the underlying graph. Consider an irreducible reversible transition matrix P with its states represented by V (V = n). Assume that the stationary distribution is uniform over all states. In spectral graph theory, the conductance associated with P is [34] Φ (P ) = inf B⊂V,B≤ n 2 i∈B,j∈Bc Pij B , (8) which characterizes how easy the probability flow can cross from one subset of nodes to its complement. If the transition matrix P is chosen such that Pij = di 0, , if j ∈ neighbor(i), else, (9) (cid:40) 1 where di denotes the degree of vertex i, then the conductance associated with random geometric graph with radius r(n) obeys Φ(P ) = Θ (r(n)) [33], where r(n) is the transmission radius. B. Single-message Dissemination in Mobile Networks We only briefly sketch the proof for Theorem 1 in this paper, since the approach is somewhat standard (see [15]). Lemma 1 implies that with high probability, the number of nodes residing in each subsquare will exhibit sharp concentration around the mean n/m once n > 32m log n. For each message Mi, denote by Ni(t) the number of users containing Mi at time t. The spreading process is divided into 2 phases: 1 ≤ Ni(t) ≤ n/2 and n/2 < Ni(t) ≤ n. As an aside, if we denote by plj the probability that l successfully transmit to j in the next time slot conditional 7 m (cid:80) n 0. plj = on the event that there are Θ(n/m) users residing in each subsquare, then if m < n 32 log n, one has if l and j can move to the same subsquare in the next time slot, else. Θ(cid:0) m (cid:1) , (cid:1) users that can lie within the same user l, there are Θ(cid:0) n a geometric random graph with r(n) = (cid:112)1/m = v(n), the transition matrix defined in (9) satisfies Plj = Θ(cid:0) m (cid:1) (cid:1) users inside the transmission with high probability Θ(cid:0) n Concentration results imply that for any given time t and any subsquare as l with high probability. On the other hand, for for all j inside the transmission range of l (where there are m n range). Therefore, if we define the conductance related to i∈B,j∈Bc plj this mobility model as Φ (n) = inf B⊂V,B≤ n , then this is order-wise equivalent to the conductance of the geometric random graph with r(n) = v(n), and hence Φ(n) = Θ(r(n)) = Θ(v(n)). B 2 1) Phase 1: Look at the beginning of each slot, all senders containing Mi may transmit it to any nodes in the 9 subsquares equally likely with constant probability by the end of this slot. Using the same argument as [15], one can see that the expected increment of Ni(t) by the end of this slot can be lower bounded by the number of nodes Ni(t) times the conductance related to the mobility model Φ(n) = Θ (v(n)) defined above. We can thus conclude that before N (t) = n/2, E (Ni(t + 1) − Ni(t) Ni(t)) ≥ b1Ni(t)Φ (n) = b1Ni(t)v(n) holds for some constant b1 and b1. Following the same martingale-based proof technique used for single-message dissemination in [15, Theorem 3.1], we can prove that for any  > 0, the time Ti1() by which Ni(t) ≥ n/2 holds with probability at least 1 −  can be bounded by (cid:18) log n + log −1 (cid:19) Ti1() = O Φ(n) = O (cid:19) (cid:18) log n + log −1 (cid:17) (cid:16) log n v(n) v(n) . (10) with Take  = n−3, then Ti1() is bounded by O probability at least 1 − n−3. 2) Phase 2: This phase starts at Ti1 and ends when Ni(t) = n. Since the roles of j and l are symmetric, the probability of j having l as the nearest neighbor is equal to the probability of l having j as the nearest neighbor. This further yields plj = pjl by observing that the transmission success probability is the same for each designated pair. Therefore, we can see: E (Ni(t + 1) − Ni(t) Ni(t)) ≥ b2 plj (cid:88) (cid:80) l∈Ni(t),j /∈Ni(t) = b2 (n − Ni(t)) ≥ b2 (n − Ni(t)) Φ(n). j /∈Ni(t),l∈Ni(t) pjl n − Ni(t) (11) (12) (13) Denote by Ti2 the duration of Phase 2. We can follow the same machinery in [17] to see: (cid:18) log n (cid:19) Φ(n) (cid:18) log n (cid:19) v(n) Ti2 = O = O (cid:113) 32 log n with probability exceeding 1 − n−3. By combining the duration of Phase 1 and Phase 2 and applying the union bound over all distinct messages, we can see that T uc holds for all distinct messages sp (i) = O v(n) (cid:16) log n (cid:17) n v(n) (cid:17) (cid:16) 1 with high probability. When v(n) > , at any time instance each node can only transmit a message to nodes at a distance at most O (v(n)), and hence it will take at least Ω (1/v(n)) time instances for Mi to be relayed to the node farthest from i at time 0, which is a universal lower bound on the spreading time. Therefore, T uc sp (i) is only a logarithmic factor away from the fundamental lower bound . It can be seen that the bottleneck of this upper Ω bound lies in the conductance of the underlying random network. When v(n) = ω , mobility accelerates spreading by increasing the conductance. The mixing time duration is much larger than the spreading time, which implies that the copies of each message is still spatially constrained in a fixed region (typically clustering around the source) without being spread out over the entire square. We note that with full mobility, the spreading time in single message dissemination case achieves the universal lower bound Θ(log n), which is much smaller than that with a limited degree of velocity. (cid:18)(cid:113) log n (cid:19) n C. Multi-message Spreading in Static Networks with RAN- DOM PUSH The proof idea of Theorem 2 is sketched in this subsection. 1) The Lower Bound on the Spreading Time: To begin our analysis, we partition the entire unit square as follows: • The above partition also allows us • The unit square is divided into a set of nonoverlapping in Fig. 2 (Note that this is a different partition from subsquares {Aj} resulting from the mobility model). tiles {Bj} each of side length(cid:112)32 log n/n as illustrated (cid:112)32 log n/n and length 1. Label the vertical strips as {Vl}(cid:16) blocks (cid:8)V b in increasing order from left to right, and denote by NVl (t) and NVl (t) the number and the set of nodes in Vl that contains M∗ by time t. • The vertical strips are further grouped into vertical j = (cid:9) each containing log n strips, i.e. V b (cid:17) 1 ≤ l ≤(cid:112)n/ (32 log n) to slice the each of width into vertical network area strips {Vl : (j − 1) log n + 1 ≤ l ≤ j log n}. j Remark 4. Since each tile has an area of 32 log n/n, con- centration results (Lemma 1) imply that there are Θ (log n) nodes residing in each tile with high probability. Since each sender only attempts to transmit to its nearest receiver, then with high probability the communication process occurs only to nodes within the same tile or in adjacent tiles. Without loss of generality, we assume that the source of M∗ resides in the leftmost vertical strip V1. We aim at counting the time taken for M∗ to cross each vertical block horizontally. In order to decouple the counting for different vertical blocks, we construct a new spreading process G∗ as follows. 8 Spreading in Process G∗: 1) At t = 0, distribute M∗ to all nodes residing in 2) Each node adopts RANDOM PUSH as the message vertical strip V1. selection strategy. (cid:110) (cid:111) (cid:18)(cid:113) n (cid:19) poly(log n) 3) Define T b t : NV b l = min as the first time that M∗ reaches vertical block V b l . For all l ≥ 2, distribute M∗ to all nodes residing in either V b l−1 or the leftmost strip of V b . l at time t = T b (t) > 0 l l It can be verified using a coupling approach that G∗ evolves than the true process. By enforcing stochastically faster mandatory dissemination at every t = T b l , we enable separate counting for spreading time in different blocks -- the spreading in V b l+1 is independent of what has happened in V b 32 log3 n blocks, the l . Roughly speaking, since there are (cid:113) n l+1 after T b spreading time over the entire region is Θ times the spreading time over a typical block. We perform a single-block analysis in the following lemma, and characterize the rate of propagation across different strips over a typical block in G∗. By Property 3) of G∗, the time taken to cross each typical block is equivalent to the crossing time in V b 1 . Specifically, we demonstrate that the time taken for a message to cross a single block is at least Ω(cid:0)w1−(cid:1) for any positive . Since the crossing time for each block in G∗ is statistically equivalent, this single-block analysis further allows us to lower bound the crossing time for the entire region. Lemma 2. Consider the spreading of M∗ over V b 1 in the original process G. Suppose each node contains at least w = ω (poly (log n)) messages initially. Define tX := w1−, and define l∗ = min{l : NVl(tX ) = O (w log n)}. Then with probability at least 1 − 3n−3, we have (a) l∗ ≤ 1 (b) ∀s (1 ≤ s < l∗), there exists a constant c31 such that 2 log n; (cid:18) log n (cid:19)s−1(cid:0)c31 n log n(cid:1) ; √ (14) NVs (tX ) ≤ w (tX ) ≤ log2 n. (c) NV 1 2 log n Sketch of Proof of Lemma 2: The proof makes use of the fixed-point type of argument. The detailed derivation is deferred to Appendix B. that NVl (tX ) decreases to O(cid:0)log2 n(cid:1) before V 1 The key observation from the above lemma is that the number of nodes in Vs containing M∗ is decaying rapidly as s increases, which is illustrated in Fig. 2. We also observe While Lemma 2 determines the number of copies of M∗ inside V1 ∼ V 1 2 log n by time tX, it does not indicate whether M∗ has crossed the block V b 1 or not by tX. It order to characterize the crossing time, we still need to examine the 2 log n+1 ∼ Vlog n. Since communication evolution in strips V 1 occurs only between adjacent strips or within the same strip, 2 log n must be relayed via a all copies lying to the right of V 1 2 log n. That said, path that starts from V1 and passes through V 1 2 log n. 9 is to the left of V 1 right of V 1 2 log n by time tX is decoupled with that to the min(cid:8)t : M∗ reaches Vlog n in G(cid:9) is smaller than tX. It can to examine how likely T ∗ 2 log n by time tX. Our objective be observed that any two substrips would never merge before T ∗ 2 since they are initially spaced at least log n tiles from each other. This allows us to treat them separately. Specifically, the following lemma provides a lower bound on T ∗ 2 by studying the process G. Lemma 3. Suppose tX = w1− and each node contains at least w distinct messages since t = 0. Then we have = 2 P (T ∗ 2 ≤ tX ) ≤ 4 n3 . (15) Proof: See Appendix C. This lemma indicates that M∗ is unable to cross V b 1 by time tX = w1− in G. Since G is stochastically faster than the original process, the time taken for M∗ to cross a vertical block in the original process exceeds tX with high probability. In other words, the number of nodes having received M∗ by tX vanishes within no more than O (log n) further strips. total, and crossing each block takes at least Ω(cid:0)w1−(cid:1) time slots, the time taken for M∗ to cross all blocks can thus be bounded below as (cid:16)(cid:112)n/poly(log n) (cid:17) (cid:18) Since there are Θ vertical blocks in (cid:19) (cid:114) T ∗ = Ω w1− n poly (log n) (16) (cid:17) (cid:16) 2) Discussion: Theorem 2 implies that (cid:16)(cid:112)n/poly(log n) (cid:17) k1−(cid:112)n/poly(log n) with high probability. if a message M∗ is injected into the network when each user contains Ω (k/poly(log n)) messages, the spreading time for M∗ is for arbitrarily small . That said, Ω there exists a gap as large as Ω from optimality. The tightness of this lower bound can be verified by deriving an upper bound using the conductance-based approach as follows. We observe that the message selection probability for M∗ is always lower bounded by 1/k. Hence, we can couple a new process adopting a different message-selection strategy such that a transmitter containing M∗ selects it for transmission with state-independent probability 1/k at each time. It can be verified that this process evolves stochastically slower than the original one. The conductance associated with the new evolution for M∗ is Φ(n) = 1 . Applying similar analysis as in [17] yields (cid:113) log n k Θ (r(n)) = O (cid:19) n (cid:18) npoly(log n)(cid:1) 1 k (cid:18)poly (log n) (cid:19) = O(cid:0)k √ Ti = O (17) with probability exceeding 1 − n−2, which is only a poly- logarithmic gap from the lower bound we derived. Φ(n) The tightness of this upper bound implies that the propaga- tion bottleneck is captured by the conductance-based measure -- the copies of each message tend to cluster around the source at any time instead of spreading out (see Fig. 4). That said, only the nodes lying around the boundary are likely to forward Figure 2. The plot illustrates that the number NVi (tX ) of nodes containing Mi in vertical strip Vi by time tX is decaying rapidly with geometric rate. 2 log n+1 ∼ Vlog n by time tX must have been all copies in V 1 forwarded (possibly in a multi-hop manner) via some nodes having received M∗ by tX. If we denote by N ∗ (tX ) the set of nodes in Vlog n/2 having received M∗ by tX in G∗, then we can construct a process G in which all nodes in N ∗ (tX ) receive M∗ from the very beginning (t = 0), and hence the evolution in G can be stochastically faster than G∗ by time tX. Vlog n/2 Vlog n/2 Spreading in Process G: Vlog n/2 Vlog n/2 1) Initialize (a): at t = 0, for all v ∈ N ∗ (tX ), distribute M∗ to all nodes residing in the same tile as v. 2) Initialize (b): at t = 0, if v1 and v2 are two nodes in N ∗ (tX ) such that v1 and v2 are less than log n tiles away from each other, then distribute M∗ to all nodes in all tiles between v1 and v2 in Vlog n/2. After this step, tiles that contain M∗ forms a set of nonoverlapping substrips. 3) By time tX = w1−, the evolution to the left of Vlog n/2 occurs exactly the same as in G∗. 4) At the first time slot in which any node in the above substrips selects M∗ for transmission, distribute M∗ to all nodes in all tiles adjacent to any of these substrips. In other words, we expand all substrips outwards by one tile. 5) Repeat from 4) but consider the new set of substrips after expansion. By our construction of G, the evolution to the left of 2 log n stays completely the same as that in G∗, and hence V 1 there is no successful transmission of M∗ between nodes in V1 ∼ V 1 2 log n−1 and those in Vlog n/2 but not contained in N ∗ (tX ). Therefore, in our new process G, the evolution Vlog n/2 the message to new users. Capacity loss occurs to the users inside the cluster since many transmissions occur to receivers who have already received the message and are thus wasted. This graph expansion bottleneck can be overcome with the assistance of mobility. D. Multi-message Spreading in Mobile Networks with MO- BILE PUSH (cid:17) (cid:16) Θ(cid:0)m log3 n(cid:1) The proof of Theorem 3 is sketched in this subsection. We divide the entire evolution process into 3 phases. The duration of Phase 1 is chosen to allow each message to be forwarded to a sufficiently large number of users. After this initial phase (which acts to "seed" the network with a sufficient number of all the messages), random gossiping ensures the spread of all messages to all nodes. 1: for the ch log n This 1) Phase phase log2 n c0m log n + m accounts = first time c6 slots, where c0, c6 and ch are constants independent of m and n. At the end of this phase, each message will be contained in at least 32m log n = Θ (m log n) nodes. The time intended for this phase largely exceeds the mixing time of the random walk mobility model, which enables these copies to "uniformly" spread out over space. We are interested in counting how many nodes will contain a particular message Mi by the end of Phase 1. Instead of counting all potential multi-hop relaying of Mi, we only look at the set of nodes that receive Mi directly from source i in odd slots. This approach provides a crude lower bound on Ni(t) at the end of Phase 1, but it suffices for our purpose. Consider the following scenario: at time t1, node i attempts to transmit its message Mi to receiver j. Denote by Zi(t) (1 ≤ i ≤ n) the subsquare position of node i, and define the relative coordinate Zij(t) := Zi(t) − Zj(t). Clearly, Zij(t) forms another two-dimensional random walk on a discrete torus. For notional convenience, we introduce the the notation P0 (·) ∆= P (· Zij(0) = (0, 0)) to denote the conditional measure given Zij (0) = (0, 0). The following lemma characterizes the hitting time of this random walk to the boundary. Lemma 4. Consider the symmetric random walk Zij(t) de- fined above. Denote the set Abd of subsquares on the boundary as Abd = or Ai = j,± (cid:26) (cid:27) (cid:18) (cid:19) (cid:18) (cid:19) ,∀j √ √ ± Ai , (cid:12)(cid:12)(cid:12)(cid:12)Ai = m 2 , j m 2 and define the first hitting time to the boundary as Thit = min{t : Zij(t) ∈ Abd}, then there is a constant ch such that (cid:18) (cid:19) P0 Thit < m ch log n ≤ 1 n4 . (18) Proof: See Appendix D. Besides, the following lemma provides an upper bound on the expected number of time slots by time t during which the walk returns to (0, 0). Lemma 5. For the random walk Zij(t) defined above, there exist constants c3 and ch such that for any t < m (cid:33) (cid:12)(cid:12)(cid:12)(cid:12)(cid:12) Zij(0) = (0, 0) ch log n : ≤ c3 log t. (cid:32) t(cid:88) k=1 E 10 (19) 1 (Zij(k) = (0, 0)) Here, 1 (·) denotes the indicator function. Sketch of Proof of Lemma 5: Denote by Hbd the event that Zij(t) hits the boundary Abd (as defined in Lemma 4) before t = m/ (ch log n). Conditional on Zij(0) = (0, 0), the probability q0 ij(t) of Zij(t) returning to (0, 0) at time t can then be bounded as (cid:0)Zij(t) = (0, 0) ∧ Hbd (cid:1) . ij(t) ≤ P0 (Hbd) + P0 q0 (20) Now, observe that when restricted to the set of sample paths where Zij(t) does not reach the boundary by t, we can couple the sample paths of Zij(t) to the sample paths of a random walk Zij(t) over an infinite plane before the corresponding hitting time to the boundary. Denote by Hbd the event that Zij(t) hits Abd by t = m/ (ch log n) , then P0 (cid:0)Zij(t) = (0, 0) ∧ Hbd (cid:16) Zij(t) = (0, 0) ∧ Hbd (cid:17) (cid:1) = P0 (cid:17) (cid:16) Zij(t) = (0, 0) (cid:16) Zij(t) = (0, 0) (cid:17) ∼ t−1 for ≤ P0 The return probability obeys P0 a random walk over an infinite plane [36], and P0 (Hbd) will be bounded in Lemma 4. Summing up all q0 ij(t) yields (19). See Appendix E for detailed derivation. . ch log n , the number of wasted transmis- In order to derive an estimate on the number of distinct nodes receiving Mi directly from source i, we need to cal- culate the number of slots where i fails to forward Mi to a new user. In addition to physical-layer outage events, some transmissions occur to users already possessing Mi, and hence are not successful. Recall that we are using one-sided push- only strategy, and hence we cannot always send an innovative message. Denote by Fi (t) the number of wasted transmissions from i to some users already containing Mi by time t. This can be estimated as in the following lemma. Lemma 6. For t0 = m sions Fi(t) defined above obeys E (Fi(t0)) ≤ c5 (21) for some fixed constant c5 with probability exceeding 1−3n−3. Sketch of Proof of Lemma 6: Consider a particular pair of nodes i and j, where i is the source and j contains Mi. A wasted transmission occurs when (a) i and j meets in the same subsquare again, and (b) i is designated as a sender with j being the intended receiver. The probability of event (a) can be calculated using Lemma 5. Besides, the probability of (b) is Θ (m/n) due to sharp concentration on NAi. See Appendix F. m log n t0 n The above result in estimating the expected number of distinct users containing Mi. However, it is not obvious whether Fi(t) exhibits desired sharp concentration. is helpful The difficulty is partly due to the dependence among {Zij(t)} for different t arising from its Markov property. Due to their underlying relation with location of i, Zij1(t) and Zij2 (t) are not independent either for j1 (cid:54)= j2. However, this difficulty can be circumvented by constructing different processes that exhibit approximate mutual independence as follows. The time duration(cid:2)1, c6 (c0m log n + m/ (ch log n)) log2 n(cid:3) (cid:0)1 ≤ j ≤ log2 n(cid:1) for some constant c6. Each of Phase 1 are divided into c6 log2 n non-overlapping subphases P1,j odd subphase accounts for m/ (ch log n) time slots, whereas each even subphase contains c0m log n slots. See Fig. 3 for an illustration. Instead of studying the true evolution, we consider different evolutions for each subphase. In each odd subphase, source i attempts to transmit message Mi to its intended receiver as in the original process. But in every even subphase, all new transmissions will be immediately deleted. The purpose for constructing these clearance or relaxation processes in even subphases is to allow for approximately independent counting for odd subphases. The duration c0m log n of each even subphase, which is larger than the typical mixing time duration of the random walk, is sufficient to allow each user to move to everywhere almost uniformly likely. 11 Figure 4. The left plot illustrates the clustering phenomena of Ni(t) in the evolution in a static network. However, even restricted mobility may allow these nodes to spread out within the mixing time duration as illustrated in the right plot. G. Define Si(t) and Si(t) as the set of messages that node i contains at time t in G and G, with Si(t) and Si(t) denoting their cardinality, respectively. For more clear exposition, we divide the entire phase into several time blocks each of length k + c0 log n/v2(n), and use tB to label different time blocks. We define N B i (tB) to denote Ni(t) with t being the starting time of time block tB. G is generated from G: everything in these two processes remains the same (including locations, movements, physical-layer outage events, etc.) except message selection strategies, detailed below: (cid:16) (cid:17) Figure 3. Phase 1 is divided into 2c6 log2 n subphases. Each odd subphase accounts for m/ (ch log n) slots, during which all nodes perform message spreading. Each even subphase contains c0m log n slots, during which no transmissions occur; it allows all nodes containing a typical message to be uniformly spread out. c0m log n + m Lemma 7. Set t to be c6 log2 n, which is the end time slot of Phase 1. The number of users containing each message Mi can be bounded below as ∀i, Ni (t) > 32m log n (22) ch log n with probability at least 1 − c7n−2. Proof: See Appendix G. further refined to Ni (t) = Θ(cid:0)m log2 n(cid:1). This implies that, In fact, if m log2 n (cid:28) n holds, the above lemma can be by the end of Phase 1, each message has been flooded to Ω (m log n) users. They are able to cover all subsquares (i.e., the messages' locations are roughly uniformly distributed over the unit square) after a further mixing time duration. 2) Phase 2: This phase starts from the end of Phase 1 and ends when Ni(t) > n/8 for all i. We use t = 0 to denote the starting slot of Phase 2 for convenience of presentation. Instead of directly looking at the original process, we generate a new process G which evolves slower than the original process Message Selection Strategy in the Coupled Process G: 1) Initialize: At t = 0, for all i, copy the set Si(t) of all messages that i contains to Si(t). Set tB = 0. 2) In the next c0 log n/v2(n) time slots, all new messages received in this subphase are immediately deleted, i.e., no successful forwarding occurs in this subphase regardless of the locations and physical- layer conditions. 3) In the next k slots, for every sender i, each message it contains is randomly selected with probability 1/k for transmission. 4) For all i, if the number of nodes containing Mi i (tB), delete Mi from some of i (tB) by the end 5) Set tB ← tB + 1. Repeat from (2) until Ni > n/8 is larger than 2 N B these nodes so that Ni(t) = 2 N B of this time block. for all i. Thus, each time block consists of a relaxation period and a spreading period. The key idea is to simulate an approximately spatially-uniform evolution, which is summarized as follows: • After each spreading subphase, we give the process a relaxation period to allow each node to move almost uniformly likely to all subsquares. This is similar to the relaxation period introduced in Phase 1. • Trimming the messages alone does not necessarily gen- erate a slower process, because it potentially increases the selection probability for each message. Therefore, we force the message selection probability to be a lower bound 1/k, which is state-independent. Surprisingly, this 0246810012345678910Spreading in Static NetworksNodes containing the messageNodes that don't contain the message0246810012345678910Spreading in Mobile Networks conservative bound suffices for our purpose because it is exactly one of the bottlenecks for the evolution. The following lemma makes a formal comparison of G and G. Lemma 8. G evolves stochastically slower than G, i.e. P (T2 > x) < P(cid:16) T2 > x (cid:17) (cid:110) ∀x > 0 where T2 = min{t : Ni(t) > n/8,∀i} and t : Ni(t) > n/8,∀i min for G and G, respectively. T2 = are the stopping time of Phase 2 (cid:111) (23) , Proof: Whenever a node i sends a message Mk to j in G: (a) if Mk ∈ Si, then i selects Mk with probability Si/k, and a random useless message otherwise; (b) if Mk /∈ Si, i always sends a random noise message. The initial condition Si = Si guarantees that Si ⊆ Si always holds with this coupling (cid:111) method. Hence, the claimed stochastic order holds. i (tB) > n/8,∀i Lemma 9. Denote by T B the stopping time block of Phase 2 in G. Then there exists a constant c14 independent of n such that 2 := min tB : N B (cid:110) (cid:17) ≤ 1 − n−2. P(cid:16) T B 2 ≤ 4 logc14 n Sketch of Proof of Lemma 9: We first look at a particular message Mi, and use union bound later after we derive the concentration results on the stopping time associated with this message. We observe the following facts: after a mixing time duration, the number of users Ni,Ak (t) containing Mi at each subsquare Ak is approximately uniform. Since i (tB) is the lower bound on the number of copies of N B Mi across this time block, concentration results suggest that i (tB)/m(cid:1). Observing from the mobility model that the position of any node inside a subsquare is i.i.d. chosen, we can derive Ni,Ak (t) = Ω(cid:0)N B E(cid:16) N B i (tB) (24) for some constant c9. A standard martingale argument then yields an upper bound on the stopping time. See Appendix H for detailed derivation. i (tB + 1) − N B (cid:17) ≥ c9 i (tB) N B i (tB) N B 2 This lemma implies that after at most 4 logc14 n time blocks, the number of nodes containing all messages will exceed n/8 with high probability. Therefore, the duration T2 of Phase 2 of G satisfies T2 = O (k log n) with high probability. This gives us an upper bound on T2 of the original evolution G. 3) Phase 3: This phase ends when Ni(t) = n for all i with t = 0 denoting the end of Phase 2. Assume that Ni,Aj (0) > 16m for all i and all j, otherwise we can let the process further n evolve for another mixing time duration Θ(cid:0)log n/v2(n)(cid:1). Lemma 10. Denote by T3 the duration of Phase 3, i.e. T3 = min{t : Ni(t) = n Ni(0) ≥ n/8,∀i}. Then there ex- ists a constant c18 such that P T3 ≤ 64 c18 k log n ≥ 1 − 15 16n2 . (25) Sketch of Proof of Lemma 10: The random push strategies are efficient near the start (exponential growth), but the evolution will begin to slow down after Phase 2. The (cid:18) (cid:19) concentration effect allows us to obtain a different evolution bound as 12 E (Ni(t + 1) − Ni(t)Ni(t) ) = E (n − Ni(t) − (n − Ni(t + 1))Ni(t) ) ≥ c18 16k (n − Ni(t)) . Constructing a different submartingale based on n − Ni(t) yields the above results. See Appendix I. 4) Discussion: Combining the stopping time in all three mp = the spreading time T d phases, we can see that: min{t : ∀i, Ni(t) = n} satisfies mp ≤ O T d (cid:18) log3 n +O (k log n)+O (k log n) = O(cid:0)k log2 n(cid:1) . (cid:19) v2(n) (cid:18)(cid:113) log n (cid:19) k It can be observed that, the mixing time bottleneck will not be critical in multi-message dissemination. The reason is that is much the mixing time in the regime v(n) = ω smaller than the optimal spreading time. Hence, the nodes have sufficient time to spread out to everywhere. The key step is how to seed the network with a sufficiently large number of copies at the initial stage of the spreading process, which is accomplished by the self-promotion phase of MOBILE PUSH. Remark 5. It can be observed that the upper bounds on spreading time within Phase 2 and Phase 3 are order-wise tight, since a gap of Ω(log n) exists even for complete graphs [16]. The upper bound for Phase 1, however, might not be necessarily tight. We note that the O(cid:0)log2 n(cid:1) factor arises of analysis. Since we consider Θ(cid:0)log2 n(cid:1) subphases in to- in the analysis stated in Lemma 7, where we assume that each relaxation subphase is of duration Θ (m log n) for ease tal, we do not necessarily need Θ (m log n) slots for each relaxation subphase in order to allow spreading of all copies. We conjecture that with a finer tuning of the concentration of measures and coupling techniques, it may be possible to obtain a spreading time of Θ(k log n). IV. CONCLUDING REMARKS In this paper, we design a simple distributed gossip-style protocol that achieves near-optimal spreading rate for multi- message dissemination, with the assistance of mobility. The key observation is that random gossiping over static geometric graphs is inherently constrained by the expansion property of the underlying graph -- capacity loss occurs since the copies are spatially constrained instead of being spread out. Encouragingly, this bottleneck can indeed be overcome in mobile networks, even with fairly limited degree of velocity. In fact, the velocity-constrained mobility assists in achieving a large expansion property from a long-term perspective, which simulates a spatially-uniform evolution. ACKNOWLEDGMENT The authors would like to thank Yudong Chen and Constan- tine Caramanis for helpful discussions. APPENDIX B. Proof of Lemma 2 13 Consider first the vertical strip Vl. Obviously, the spreading within Vl will be influenced by nodes residing in adjacent strips Vl−1,Vl+1, and Vl itself. Define a set of i.i.d. Bernoulli random variables {Xv,t} such that 1 w . P (Xv,t = 1) = For any v ∈ NVl−1 (tX )(cid:83)NVl (tX )(cid:83)NVl+1(tX ), the proba- bility of node v selecting M∗ for transmission at time t can be bounded above by P (Xv,t = 1). Simple coupling argument yields the following stochastic order (27) 1 (v selects M∗ for transmission at t) Similarly, the stochastic order implies that NVl−1 (tX )+NVl (tX )+NVl+1 (tX ) A. Proof of Lemma 1 that 2b/3m ≤ E(cid:0)NA(i)(t)(cid:1) ≤ 4b/3m. For each node j, define Let us look at a typical time slot t at subsquare Ai. We know the indicator variable Xj,Ai(t) := 1{j lies in Ai at t}. Then, {Xj,Ai(t) : 1 ≤ j ≤ b} forms a set of i.i.d. random variables (cid:110) each satisfying 2 Define another two sets of i.i.d. Bernoulli random variables Xub such that 3m ≤ P (Xj,Ai(t) = 1) ≤ 4 3m. (t) : 1 ≤ j ≤ b (t) : 1 ≤ j ≤ b (cid:111) (cid:111) (cid:110) Xlb j,Ai j,Ai (cid:17) (cid:17) and P(cid:16) P(cid:16) A(i)(t) := (cid:80) Xub Xlb j,Ai j,Ai (t) = 1 (t) = 1 = 4 = 2 3m , 3m . (cid:80) P(cid:16) We also define N ub A(i)(t) := (t). The following stochastic orders can be imme- 1≤j≤b (t) and N lb Xub j,Ai 1≤j≤b diately observed through simple coupling arguments Xlb j,Ai i.e. for any positive d, we have N lb A(i)(t) > d N ub A(i)(t) > d . Applying Chernoff bound yields A(i)(t) (cid:22) NA(i)(t) (cid:22) N ub N lb A(i)(t), (cid:17) ≤ P(cid:0)NA(i)(t) > d(cid:1) ≤ P(cid:16) (cid:19) (cid:18)  b(cid:88) (cid:18) NA(i)(t) ≥ (1 + )4b (t) ≥ (1 + )4b (cid:19) Xub 3m 3m j,Ai j=1  P ≤ P ≤ exp − 2b2 3m . We can thus observe through union bound that (cid:19) (cid:18) (cid:18) (cid:18) P ∃(i, t) such that NA(i)(t) ≥ (1 + )4b 3m (cid:19) ≤ mn2P ≤ n3 exp NA(i)(t) ≥ (1 + )4b − 2b2 3m 3m (cid:18) NA(i)(t) ≤ (1 − )2b P 3m (cid:18) (cid:19) (cid:19) . ≤ P ≤ exp N lb (cid:19) A(i)(t) ≤ (1 − )2b (cid:18) − b2 3m 3m . Therefore, we have (cid:18) ∃(i, t) such that NA(i)(t) ≤ (1 − )2b (cid:18) (cid:19) 3m (cid:19) P ≤ n3 exp − b2 3m . (cid:16)− 2 3 b m (cid:17) (cid:28) n−c holds for any NVl (tX ) (cid:88) v∈ l+1(cid:83) i=l−1 ≤ tX(cid:88) tX(cid:88) t=1 (cid:22)st NVi (tX ) (cid:88) t=1 v=1 (26) (cid:17) NVl−1 (tX )+NVl (tX )+NVl+1 (tX ) Xv,t, (28) where (cid:22)st denotes stochastic order. NVl+1(tX ) > ω (w log n), then we have If NVl−1(tX ) + N x Vl 2 w (cid:0)NVl−1(tX ) + NVl+1 (tX )(cid:1)(cid:27) (cid:19) (cid:0)NVl−1(tX ) + NVl+1(tX )(cid:1)(cid:27)  NVj (tX ) (tX ) > 1 w j=l−1 3 2 NVl−1 (tX )+NVl (tX )+NVl+1 (tX ) 3 2 NVl (tX ) > 1 − 3 2 1 w 1 w (cid:26) (cid:26)(cid:18) NVl  tX(cid:88)  tX(cid:88) t=1 E (tX ) > 3 2 P ≤ P = P ≤ P (cid:19)  l+1(cid:88) (cid:88) v=1 (cid:88) (29) Xv,t >  (30) Xv,t t=1 v=1 ≤ 1 n5 ,  tX(cid:88) E where (30) follows from the stochastic order (28), and the last inequality follows from large deviation bounds and the observation that NVl−1 (tX )+NVl (tX )+NVl+1 (tX ) (cid:88)  = ω (log n) . Xv,t When b = ω (m log n), exp positive constant c; when b = Θ (m log n) and b > 32m log n, taking  = 3 4 completes our proof. t=1 v=1 Besides, if NVl−1 (tX ) + NVl+1(tX ) = O (w log n), then NVs(tX ) (cid:18) 4 log n (cid:18) 4 log n ≤ NVs(tX ) + NV2L∗−s (tX ) ≤ (cid:19)s−1(cid:0)NV1(tX ) + NV2L∗−1 (tX )(cid:1) (cid:19)s−1(cid:0)c31 n log n(cid:1) , √ ≤ w w √ where the last inequality arises from the fact that there are at most O ( n log n) nodes residing in each strip with high probability. Suppose that l∗ > log n/2, then we have This shows the geometric decaying rate of NVs(tX ) in s. (cid:18) 4 log n (cid:19) 1 2 log n−1(cid:0)c31 (cid:28) 1 = o(cid:0)w− log n(cid:1) , w n log n(cid:1) √ NV 1 2 log n (tX ) = where contradiction arises. Hence, l∗ < log n/2 with high probability. Additionally, we can derive an upper bound on NVlog n/2 using the same fixed-point arguments as follows NVlog n/2(tX ) ≤ max(cid:8)log2 n, (cid:18) 4 log n w (33) = log2 n 2 log n−1(cid:0)NV1(tX ) + NVlog n−1(tX )(cid:1)(cid:41) (cid:19) 1 we have 2 w NVl (tX ) > P(cid:8)NVl (tX ) > 3 log2 n(cid:9) (cid:26) (cid:0)NVl−1 (tX ) + NVl+1(tX )(cid:1) + 2 log2 n NVl (tX ) >   l+1(cid:88)  ,  tX(cid:88) (cid:88)  + log2 n NVl−1 (tX )+NVl (tX )+NVl+1 (tX ) Yv,t > log2 n NVj (tX ) j=l−1 1 w v=1 t=1 ≤ P ≤ P ≤ P (31) (cid:18) c21 (cid:19)log2 n ≤ (c21e) Yv,t Xv,t − 1/w. Hence, ∆= where = 1 − 1/w with := w log2 n/ (NV1(tX ) + NV2(tX ) + NV3(tX )) = Ω (log n). By applying [35, Theorem A.1.12], we can show that there exist constants c21 and c21 such that Yv,t 1/w. Let β − 1 probability log n − log2 n·log log n ≤ 1 n5 . (31) ≤ (32) Define l∗ := min{l : NVl (tX ) = O (w log n)} and L∗ := min{l∗, 0.5 log n}. Since NVL∗+1(tX ) + NVL∗−1(tX ) ≥ NVL∗−1 (tX ) = ω (w log n), we can derive with similar spirit that (cid:0)NVL∗+1(tX ) + NVL∗−1(tX )(cid:1) (cid:0)NVL∗ (tX ) + NVL∗+2(tX )(cid:1) NVL∗ (tX ) ≤ 2 w NVL∗+1(tX ) ≤ 2 w with probability at least 1 − n−5. Similarly, if NVL∗ (tX ) + NVL∗+2(tX ) = ω (w log n), we can derive if NVL∗ (tX ) + NVL∗+2(tX ) = with high probability. But O (w log n), it can still be shown that NVL∗+1(tX ) ≤ log2 n ≤ log n w NVL∗−2 (tX ) by observing that NVL∗−2(tX ) = ω (w log n). Combining all these facts yields ≤ 3 log n w ≤ 3 log n w 6 log n NVL∗−1 (tX ) + NVL∗+1(tX ) ≤ 2 w log n w (cid:0)NVL∗−2 (tX ) + NVL∗ (tX )(cid:1) + (cid:0)NVL∗+2 (tX ) + NVL∗ (tX ) + NVL∗−2(tX )(cid:1) (cid:0)NVL∗−2(tX ) + NVL∗ (tX ) + NVL∗+2(tX )(cid:1) (cid:0)NVL∗−2(tX ) + NVL∗+2(tX )(cid:1) + (cid:0)NVL∗+1(tX ) + NVL∗−1 (tX )(cid:1) . (cid:0)NVL∗−2 (tX ) + NVL∗+2 (tX )(cid:1) NVL∗−1(tX ) + NVL∗+1(tX ) w2 ≤ 4 log n w Simple manipulation gives us 14 (cid:27) with high probability. Proceeding with similar spirit gives us: for all s (0 ≤ s < L∗ ≤ log n/2) NVL∗−s (tX ) + NVL∗+s (tX ) (cid:0)NVL∗−s−1 (tX ) + NVL∗+s+1 (tX )(cid:1) (34) holds with probability at least 1−n−4. By iteratively applying (34) we can derive that for any s (1 ≤ s < L∗), ≤ 4 log n w with probability at least 1 − n−3. C. Proof of Lemma 3 Define a set of Bernoulli random variables {Xt} such that Xt = 1 if there is at least one node inside these substrips selecting M∗ for transmission at time t and Xt = 0 otherwise. By observing that the size of each "substrip" will not exceed 2 and that each tile contains O (log n) nodes, the probability P (Xt = 1) can be bounded above by for some constant c40. This inspires us to construct the following set of i.i.d. Bernoulli Θ(cid:0)log3 n(cid:1) tiles before T ∗ 1 −(cid:0)1 − 1 random variables(cid:8)X t  (cid:1)Θ(log3 n) ≤ c40 log3 n (cid:9) through coupling as follows: 1, w.p. if Xt = 1, then Xt = 1; if Xt = 0, then Xt = 0, otherwise. 1−P(Xt=1) −P(Xt=1) c40 log3 n w w w , (35) 1, with probability c40 log3 n 0, w That said, (cid:40) . 2 P t=1 t=1 T ∗ T ∗ log n Xt = Xt = Xt ≥ otherwise. 2(cid:88) Additionally, large deviation bounds yields Our way for constructing(cid:8)Xt (cid:9) implies that 2(cid:88) (cid:33) (cid:0)Xt − E(cid:0)Xt (cid:1)(cid:1) ≥ log n (cid:0)Xt − E(cid:0)Xt (cid:1)(cid:1) ≥ log n (cid:18) e (cid:19) log n Define β− 1 := w log n gives (cid:32) tX(cid:88) (cid:32) tX(cid:88) (cid:32) tX(cid:88) Xt ≥ log n 2 3c40 log3 n = ≤ P ≤ P t=1 t=1 t=1 w 2 3 (38) ≤ 3 ≤ 1 n5 , β which further results in P (T ∗ 2 > tX ) ≥ 1 − 1 n5 . (37) (cid:33) − log3 n (cid:33) w . (38) 3c40 log2 n, [35, Theorem A.1.12] (39) (40) To conclude, the message M∗ is unable to cross V B tX = w1− with high probability. 1 by time D. Proof of Lemma 4 Define two sets of random variables {Xij(t)} and {Yij(t)} to represent the coordinates of Zij(t) in two dimensions, respectively, i.e. Zij(t) = (Xij(t), Yij(t)). Therefore, for any A ∈ Abd, we can observe P0 (Zij(t) = A) Xij(t) = ± √ Xij(t) ≥ m 2 m 2 Xij(t + 1) − Xij(t) ≤ 2 and then large deviation results Besides, we notice that E (Xij(t + 1) − Xij(t)) = 0, implies ≤ P0 ≤ 4P0 (cid:91) (cid:19) Yij(t) = ± (cid:18) (cid:18) (cid:19) m 2 √ √ . (cid:18) (cid:19) √ m 2 (cid:19) P0 Xij(t) ≥ ≤ exp for some constant ch. We thus derive P0 n−6 for any t < m ch log n, which leads to (cid:18) (cid:18) m P0 ≤ P0 ≤ m ch log n Thit < ∃t < ch log n √ · 4 m ch log n m · 4n−6 ≤ 1 n4 . (cid:18) (cid:16) (cid:19) − 6m cht Xij(t) ≥ √ m 2 (41) (cid:17) ≤ (cid:19) and ∃A ∈ Abd s.t. Zij(t) = A 15 E. Proof of Lemma 5 ; (36) It can be observed that Zij(t) is a discrete-time random walk which at each step randomly moves to one of 25 sites each with some constant probability. Formally, we can express it as follows: for a ≤ 2,b ≤ 2: a (42) a≤2,b≤2 P (Zij(t + 1) − Zij(t) = (a, b) Zij(t)) = pa,b holds before Zij(t) hits the boundary, where pa,b are pa,b = 1. fixed constants independent of n, and (cid:80) P(cid:16) Zij(t + 1) − Zij(t) = (a, b) Zij(t) (cid:17) We construct a new process is random walk Zij(t) plane with Define the event Hbd = {Thit < m/ (ch log n)} where Thit is the hitting time to the boundary as defined in Lemma 4. When restricted to the sample paths where Zij(t) does not hit the boundary by t, we can couple the sample paths of Zij(t) to those of Zij(t) before the corresponding hitting time to the boundary. such that = pa,b. "infinite" Zij(t) over an It is well known that for a random walk Zij(t) over an ij ∼ infinite 2-dimensional plane, the return probability obeys q0 t−1 [36]. Specifically, there exists a constant c3 such that (cid:16) Zij(t) = (0, 0) (cid:17) ≤ c3/t. ij(t) ∆= P0 q0 (43) Hence, the return probability q0 the original walk Zij(t) satisfies ij(t) ∆= P0 (Zij(t) = (0, 0)) of q0 ij(t) + P0 = P0 ( Zij(t) = (0, 0)Hbd) P (Hbd) (cid:1) (cid:0)Zij(t) = (0, 0) ∧ Hbd (cid:16) Zij(t) = (0, 0) ∧ Hbd (cid:16) Zij(t) = (0, 0) (cid:17) ≤ P0 (Hbd) + P0 ≤ P0 (Hbd) + P0 ≤ 1 n4 + c3 t ≤ 2c3 t , (cid:17) (44) (45) where (45) arises from the coupling of Zij(t) and Zij(t), and the upper bound on P (Hbd) is derived in Lemma 4. Hence, the expected number of time slots in which i and j move to the can be bounded same subsquare by time t above as 1 < t < m (cid:16) ch log n (cid:17) (cid:12)(cid:12)(cid:12)(cid:12)(cid:12) Zij(0) = (0, 0) (cid:33) 1 (Zij(l) = (0, 0)) ≤ 2c3 ≤ c3 log t 1 l E (cid:32) t(cid:88) t(cid:88) l=1 l=1 for some constant c3. F. Proof of Lemma 6 Define ti(j) as the first time slot that j receives Mi. A "conflict" event related to Mi is said to occur if at any time slot the source i moves to a subsquare that coincides with any user j already possessing Mi. Denote by Ci(t) the total amount of conflict events related to Mi that happen before t , which can be characterized as follows t ≤ m (cid:16) E (Ci(t)) ch log n (cid:17)  (cid:88) (cid:32) t(cid:88) j∈Ni(t) t(cid:88) k=ti(j)+1  (46) (cid:33) = E 1 (Zij(k) = 0Zij (ti(j)) = 0 ) k=1 (47) 1 (Zij(k) = 0Zij(0) = 0 ) ≤ tE ≤ c3t log t, (48) where (47) arises from the facts that Ni (t) ≤ t and Zij is stationary, and (48) follows from Lemma 5. Lemma 1 implies that there will be more than n/6m users residing in each subsquare with high probability. If this occurs for every subsquare in each of t slots, whenever i and j happens to stay in the same subsquare, the probability that i can successfully transmit Mi to j can be bounded above as θ (1 − θ) · 6m/n. Therefore, the amount of successful "retransmissions" can be bounded as E (Fi(t)) ≤ θ (1 − θ) · 6m n E (Ci(t)) ≤ c5 mt log t n for some fixed constant c5. Setting t = t0 yields E (Fi(t0)) ≤ c5 m log n n t0 = o (t0) . (49) (50) This inequality is based on the assumption that Thit > t0 and that concentration effect occurs, which happens with probability at least 1 − 3n−3. G. Proof of Lemma 7 Recall that P1,j denotes the jth subphase of Phase 1. There- fore, in the 1st odd subphase, the total number of successful transmissions from i (including "retransmissions"), denoted by Gi, can be bounded below as Gi ≥ c7m/ log n (51) with probability exceeding 1 − c7/n4 for some constants and c7 and c7. This follows from simple concentration inequality and the fact that E (Gi) ≥ c (1 − θ) θt. It can be noted that Gi exhibits sharp concentration based on simple large deviation argument. Also, Markov bound yields E (Fi(t0)) ≤ n P t0 m log n Fi(t0) > 65c5 1 . 65 (52) Since the duration of any odd subphase t0 = m/ (ch log n) obeys mt0 log n/n (cid:28) t0, this implies that the number of dis- tinct new users that can receive Mi within this odd subphase, denoted by N i (P1,1), can be stochastically bounded as 65c5mt0 log n/n = (cid:19) (cid:18) (cid:18) (cid:19) P N i (P1,1) < c8 m log n < 1 64 (53) for some constant c8. Note that we use the bound 1 instead of 1 65 in order to account for the deviation of Gi. 64 here 16 We observe that there are in total c6m log n/ch slots for spreading in Phase 1, therefore the total number of dis- tinct nodes receiving Mi in Phase 1 is bounded above by c6m log n/ch (cid:28) n/2. Mixing behavior combined with con- centration effect thus indicates that during any odd subphase, there are at least n/12m nodes not containing Mi in each subsquare, and each transmitter is able to contact a new receiver (who does not have Mi) in each slot with probability at least 1/12. This motivates us to construct the following stochastically slower process for odd subphase j: (a) there are n/2 nodes residing in the entire square; (b) each transmission event is declared "failure" regardless any other state with probability 11/12; (c) the evolution in different odd subphases are independent; (d) other models and strategies remain the same as the original process. Obviously, this constructed process allows us to derive a lower bound on Ni(t) by the end of Phase 1. Proceeding with similar spirit in the analysis for 1st odd subphase, we can see that the number of distinct new users receiving Mi in odd subphase j of our constructed process, denoted by Ni(P1,j), can be lower bounded as (cid:18) P Ni (P1,j) < c8 m log n (cid:19) (cid:111) (cid:110) Ni(P1,j) 1 64 < for some constant c8. By noticing that ally independent, simple large deviation inequality yields are mutu- log2n odd subphases s.t. Ni (P1,j) > c8 (54) (cid:19) m log n (cid:18) P ∃ c6 2 >1 − 1 n5 . (cid:88) Taking c6 such that c6c8/2 > 32, we can see that Ni (P1,j) > 32m log n (55) odd subphase j phase (cid:80) holds with probability at in the original process is stochastically larger total number of distinct users receiving Mi least 1 − o(n−3). Since Ni (t) than the in any sub- Ni (P1,j), we can immediately observe: Ni (t) > 32m log n by the end of Phase 1 with high prob- ability. Furthermore, applying union bound over all distinct messages completes the proof of this lemma. odd subphase j H. Proof of Lemma 9 We consider the evolution for a typical time block [tB, tB + 1]. During any time slot in this time block, each node l /∈ N B i (tB) lying in subsquare Ak will receive Mi from a node in N B i (tB) with probability at least l receives Mi at t from a node in N B Ni,Ak (t) 2n/m ≥ c9 N B i (tB) nk 1 k i (tB) ≥ c8 P(cid:16) (cid:17) for constants c8 and c9, because concentration results imply that: (1) there will be at least N B i (tB)/3m nodes belonging to N B i (tB) residing in each subsquare Aj; (2) there are at most (cid:17)k ≥ c9 N B 2n/m nodes in each subsquare; (3) each successful transmis- sion allows l to receive a specific message Mi with state- independent probability 1/k. Therefore, each node j /∈ Ni(tB) will receive Mi from a node in N B i (tB) by tB + 1 with 1 − c9 N B i (tB ) i (tB)/n nk for some constant c9. Since there are in total n − N B i (tB) nodes not containing Mi at the beginning of this time block, we have probability exceeding 1 −(cid:16) P(cid:16) ≥ (cid:16) l receives Mi from a node in N B n − N B i (tB) by tB + 1 (cid:17) (cid:17) c9 N B i (tB)/n i (tB) ≥ c9 2 N B i (tB). Moreover, after the relaxation period of c13 log n/v2(n) time slots, all these nodes containing Mi will be spread out to all subsquares, then similar arguments will hold for a new time block. The mixing time period plays an important role in maintaining an approximately uniform distribution of the locations of each node. Thus, we can derive the following evolution equation: (cid:32) E = − E ≤ − E − 1 N B N B 1 (cid:32) N B  N B i (tB + 1) i (tB) i (tB) i (tB + 1) − N B N B i (tB + 1) N B (cid:105)2 i (tB + 1) − N B (cid:104) N B i (tB) 2 i (tB) i (tB) (cid:33) i (tB) (cid:12)(cid:12)(cid:12)(cid:12)(cid:12) N B (cid:12)(cid:12)(cid:12)(cid:12)(cid:12) N B (cid:12)(cid:12)(cid:12)(cid:12)(cid:12)(cid:12)(cid:12) N B i (tB) i (tB) (cid:33)  (56) (57) (58) (59) 17 (cid:111) ≥ 1 − 1 n3 . The fact that T B P(cid:110) T B i,2 = T B i,2 ≤ 4 logc14 n = P(cid:110) T B (cid:111) i,2 ∧ n gives P(cid:110)∃i : T B Finally, applying union bound yields i,2 > 4 logc14 n i,2 ≤ 4 logc14 n (cid:111) ≤ 1 n2 . I. Proof of Lemma 10 Define Ti,3 = min{t : Ni(t) = n} as the stopping time for all i. In each time slot, any node l /∈ Ni(t) will receive Mi with probability at least c18/16n for a constant c18 simply because each transmitter in Ni(t) will select Mi for transmission to least 1/k. This yields the following l with probability at inequality: E (Ni(t + 1) − Ni(t)Ni(t) ) ≥ c18 16k Define Zi,3(t) = (n − Ni(t))(cid:0)1 − c18 ulation we get E (Zi,3(t + 1) Zi,3(t)) ≥ Zi,3(t), which indicates that {Zi,3(t)} forms a submartingale. Take t4 = 64k log n/c18, we have 16k (61) (n − Ni(t)) . (cid:1)−t, then by manip- (cid:17)t4 15n E [n − Ni(t4)] ≤(cid:16) 1 − c18 16k , 16 ∴ P (Ni (t4) ≤ n − 1) ≤ E [(n − Ni(t4))] ≤ 15 16n3 . Moreover, applying union bound yields P (∃i : Ni (t4) ≤ n − 1) ≤ nP (Ni (t4) ≤ n − 1) ≤ 15 16n2 . Let T3 = maxi Ti,3. Combining the above results, we can see that the duration T3 of Phase 3 satisfies T3 = O (k log n) with probability at least 1 − 15 16n2 . REFERENCES [1] Y. Chen, S. Shakkottai, and J. Andrews, "Sharing multiple messages over mobile networks," IEEE Infocom, pp. 658 -- 666, April 2011. [2] D. Qiu and R. Srikant, "Modeling and performance analysis of bittorrent-like peer-to-peer networks," ACM SIGCOMM, pp. 367 -- 378, 2004. [3] X. Yang and G. de Veciana, "Service capacity of peer to peer networks," IEEE INFOCOM, vol. 4, pp. 2242 -- 2252 vol.4, March 2004. [4] B. Pittel, "On spreading a rumor," SIAM Journal of Applied Mathemat- ics, vol. 47, no. 1, pp. 213 -- 223, 1987. [5] R. Karp, C. Schindelhauer, S. Shenker, and B. Vocking, "Randomized rumor spreading," Proceedings of the 41st Annual Symposium on Foun- dations of Computer Science, pp. 565 -- 574, 2000. [6] J. Tsitsiklis, Problems in decentralized decision making and computa- tion, PhD dissertation, LIDS, MIT, Cambridge, 1984. [7] A. Kashyap and R. Srikant, "Quantized consensus," Automatica, vol. 43, pp. 1192 -- 1203, 2007. [8] S. Boyd, A. Ghosh, B. Prabhakar, and D. Shah, "Randomized gossip algorithms," IEEE Transactions on Information Theory, vol. 52, no. 6, pp. 2508 -- 2530, June 2006. [9] A. Nedic and A. Ozdaglar, "Distributed subgradient methods for multi- agent optimization," IEEE Transactions on Automatic Control, vol. 54, no. 1, pp. 48 -- 61, Jan. 2009. [10] K. Jung, D. Shah, and J. Shin, "Distributed averaging via lifted markov chains," IEEE Transactions on Information Theory, vol. 56, no. 1, pp. 634 -- 647, January 2010. [11] E. Modiano, D. Shah, and G. Zussman, "Maximizing throughput in wireless networks via gossiping," ACM SIGMETRICS, pp. 27 -- 38, 2006. ≤ − c13 1 Ni(tB) , i,2 i,2 i,2 i,2 (cid:17) (cid:16) (cid:16) (cid:111) i,2 = min , tB ≥ 0 tB ∧ T B tB ∧ T B i (tB) > n/8 E(cid:16) Zi (cid:17)(cid:17) ≤ Zi (cid:111) −tB / N B (tB + 1) ∧ T B for some constant c13 < 1, where the inequality (58) follows from the fact N B i (tB) guaranteed by Step (4). Let T B , and define Zi(tB) = (1 − c13) (cid:110) i (tB +1) ≤ 2 N B tB : N B (cid:16) i (tB). Simple manipulation yields tB ∧ T B i,2 ∧ n, which satisfies T B (cid:17) Zi (cid:16) (cid:110) Zi (cid:17) which indicates that forms a non- negative supermartingale. We further define a stopping time i,2 ≤ n < ∞. The Stopping T B i,2 = T B (cid:16) T B = E(cid:16) Zi (cid:17)(cid:17) (cid:16) T B Time Theorem yields [37, Theorem 5.7.6] ≤ E(cid:16) Zi (0) (cid:17) i,2 ∧ T B i,2 1 (cid:17) ≤ max N B N B i (0) (cid:27) (cid:26) E(cid:16) Zi =⇒ E(cid:16) P(cid:110) T B (cid:17)(cid:17) (cid:17) (cid:16) T B (cid:18) Set c14 = (1 − c13)−1, then we have (1 − c13) i N B T B i,2 c 14 (cid:19) = P i (0) (cid:111) T B 14 > n4 i,2 c i,2 > 4 logc14 n (60) − T B i,2 < n. ≤ E = i,2 i,2 , < n4 1 n3 . 18 [12] A. Eryilmaz, A. Ozdaglar, D. Shah, and E. Modiano, "Distributed cross- layer algorithms for the optimal control of multihop wireless networks," IEEE/ACM Transactions on Networking, vol. 18, no. 2, pp. 638 -- 651, Apr. 2010. [13] A. Demers, D. Greene, C. Houser, W. Irish, J. Larson, S. Shenker, H. Sturgis, D. Swinehart, and D. Terry, "Epidemic algorithms for replicated database maintenance," Proceeding of the sixth annual ACM symposium on principles of distributed computing, pp. 1 -- 12, 1987. [14] B. Pittel, "On spreading a rumor," SIAM Journal on Applied Mathemat- ics, vol. 47, no. 1, pp. pp. 213 -- 223, 1987. [15] D. Shah, "Gossip algorithms," Foundations and Trends in Networking, vol. 3, no. 1, pp. 1 -- 125, April 2009. [16] S. Sanghavi, B. Hajek, and L. Massoulie, "Gossiping with multiple messages," IEEE Transactions on Information Theory, vol. 53, no. 12, pp. 4640 -- 4654, Dec. 2007. [17] D. Mosk-Aoyama and D. Shah, "Fast distributed algorithms for com- puting separable functions," IEEE Transactions on Information Theory, vol. 54, no. 7, pp. 2997 -- 3007, July 2008. [18] A. Sarwate and A. Dimakis, "The impact of mobility on gossip algo- rithms," IEEE INFOCOM, pp. 2088 -- 2096, April 2009. [19] A. Clementi, A. Monti, F. Pasquale, and R. Silvestri, "Information spreading in stationary Markovian evolving graphs," IEEE Transactions on Parallel and Distributed Systems, vol. 22, no. 9, pp. 1425 -- 1432, Sep. 2011. [20] H. Baumann, P. Crescenzi, and P. Fraigniaud, "Parsimonious flooding in dynamic graphs," Proceedings of the 28th ACM symposium on Principles of distributed computing, pp. 260 -- 269, 2009. [21] A. Clementi, R. Silvestri, and L. Trevisan, "Information spreading in dynamic graphs," Nov. 2011. [Online]. Available: http://arxiv.org/abs/ 1111.0583 [22] A. Pettarin, A. Pietracaprina, G. Pucci, and E. Upfal, "Tight bounds on information dissemination in sparse mobile networks," Proceedings of the 30th annual ACM SIGACT-SIGOPS symposium on principles of distributed computing, pp. 355 -- 362, 2011. [23] S. Deb, M. Medard, and C. Choute, "Algebraic gossip: a network coding approach to optimal multiple rumor mongering," IEEE Transactions on Information Theory, vol. 52, no. 6, pp. 2486 -- 2507, June 2006. [24] B. Haeupler, "Analyzing network coding gossip made easy," 43rd ACM Symposium on Theory of Computing, pp. 2088 -- 2096, June 2011. [25] R. Zheng, "Information dissemination in power-constrained wireless networks," IEEE INFOCOM, pp. 1 -- 10, April 2006. [26] S. Subramanian, S. Shakkottai, and A. Arapostathis, "Broadcasting in sensor networks: The role of local information," IEEE/ACM Transac- tions on Networking, vol. 16, no. 5, pp. 1133 -- 1146, Oct. 2008. [27] G. Resta and P. Santi, "On the fundamental limits of broadcasting in wireless mobile networks," IEEE INFOCOM, pp. 1 -- 5, 14-19 2010. [28] M. Neely and E. Modiano, "Capacity and delay tradeoffs for ad hoc mobile networks," IEEE Transactions on Information Theory, vol. 51, no. 6, pp. 1917 -- 1937, June 2005. [29] M. Grossglauser and D. Tse, "Mobility increases the capacity of ad hoc wireless networks," IEEE/ACM Transactions on Networking, vol. 10, no. 4, pp. 477 -- 486, Aug 2002. [30] A. El Gamal, J. Mammen, B. Prabhakar, and D. Shah, "Optimal throughput-delay scaling in wireless networks -- Part I: the fluid model," IEEE Transactions on Information Theory, vol. 52, no. 6, pp. 2568 -- 2592, June 2006. [31] L. Ying, S. Yang, and R. Srikant, "Optimal delay-throughput tradeoffs in mobile ad hoc networks," IEEE Transactions on Information Theory, vol. 54, no. 9, pp. 4119 -- 4143, Sep. 2008. [32] X. Lin, G. Sharma, R. Mazumdar, and N. Shroff, "Degenerate delay- capacity tradeoffs in ad-hoc networks with Brownian mobility," IEEE Transactions on Information Theory, vol. 52, no. 6, pp. 2777 -- 2784, June 2006. [33] C. Avin and G. Ercal, "On the cover time and mixing time of random geometric graphs," Theoretical Computer Science, vol. 380, no. 1-2, pp. 2 -- 22, 2007. [34] R. Durrett, Random Graph Dynamics, ser. Cambridge Series in Sta- New York, NY: Cambridge tistical and Probabilistic Mathematics. University Press. [35] N. Alon and J. H. Spencer, The Probabilistic Method, ser. Wiley- John Interscience Series in Discrete Mathematics and Optimization. Wiley & Sons, Inc., 2008. [36] F. G. Foster and I. J. Good, "On a generalization of Pólya's random-walk theorem," The Quarterly Journal of Mathematics, vol. 4, pp. 120 -- 126, June 1953. [37] R. Durrett, Probability: Theory and Examples (4th Edition). Cambridge University Press, 2010.
1911.06511
1
1911
2019-11-15T08:25:13
Graph Iso/Auto-morphism: A Divide-&-Conquer Approach
[ "cs.SI", "cs.DS" ]
The graph isomorphism is to determine whether two graphs are isomorphic. A closely related problem is automorphism detection, where an isomorphism between two graphs is a bijection between their vertex sets that preserves adjacency, and an automorphism is an isomorphism from a graph to itself. Applications of graph isomorphism/automorphism include database indexing, network simplification, network anonymization. By graph automorphism, we deal with symmetric subgraph matching (SSM), which is to find all subgraphs that are symmetric to a given subgraph in G. An application of SSM is to identify multiple seed sets that have the same influence power as a seed set found by influence maximization in a social network. To test two graphs for isomorphism, canonical labeling has been studied to relabel a graph in such a way that isomorphic graphs are identical after relabeling. Efficient canonical labeling algorithms have been designed by individualization-refinement. They enumerate all permutations using a search tree, and select the minimum as the canonical labeling, which prunes candidates during enumeration. Despite high performance in benchmark graphs, these algorithms face difficulties in handling massive graphs. In this paper, we design a new efficient canonical labeling algorithm DviCL. Different from previous algorithms, we take a divide-&-conquer approach to partition G. By partitioning G, an AutoTree is constructed, which preserves symmetric structures and the automorphism group of G. The canonical labeling for a tree node can be obtained by the canonical labeling of its child nodes, and the canonical labeling for the root is the one for G. Such AutoTree can also be effectively used to answer the automorphism group, symmetric subgraphs. We conducted extensive performance studies using 22 large graphs, and confirmed that DviCL is much more efficient and robust than the state-of-the-art.
cs.SI
cs
Graph Iso/Auto(cid:173)morphism: A Divide(cid:173)&(cid:173)Conquer Approach Can Lu, Jeffrey Xu Yu, Zhiwei Zhang#, Hong Cheng The Chinese University of Hong Kong, Hong Kong, China; # Hong Kong Baptist University, Hong Kong, China {lucan,yu,hcheng}@se.cuhk.edu.hk; # [email protected] ABSTRACT 1. INTRODUCTION The graph isomorphism is to determine whether two graphs are iso- morphic. A closely related problem is graph automorphism (sym- metry) detection, where an isomorphism between two graphs is a bijection between their vertex sets that preserves adjacency, and an automorphism is an isomorphism from a graph to itself. Applica- tions of graph isomorphism and automorphism detection include database indexing, network model, network measurement, network simplification, and social network anonymization. By graph au- tomorphism, we deal with symmetric subgraph matching (SSM), which is to find all subgraphs in a graph G that are symmetric to a given subgraph in G. An application of SSM is to identify multiple seed sets that have the same influence power as a set of seeds found by influence maximization in a social network. To test two graphs for isomorphism, canonical labeling has been studied to relabel a graph in such a way that isomorphic graphs are identical after rela- beling. Efficient canonical labeling algorithms have been designed by individualization-refinement. They enumerate all permutations of vertices using a search tree, and select the minimum permuta- tion as the canonical labeling. The candidates are pruned by the minimum permutation during enumeration. Despite their high per- formance in benchmark graphs, these algorithms face difficulties in handling massive graphs, and the search trees used are for pruning purposes which cannot answer symmetric subgraphs matching. In this paper, we design a new efficient canonical labeling algo- rithm DviCL. DviCL designed is based on the observation that we can use the k-th minimum permutation as the canonical labeling. Different from previous algorithms, we take a divide-and-conquer approach to partition a graph G. By partitioning G, an AutoTree is constructed, which preserves symmetric structures as well as the automorphism group of G. The canonical labeling for a tree node can be obtained by the canonical labeling of its child nodes. and the canonical labeling for the root is the one for G. Such AutoTree can also be effectively used to answer the automorphism group, symmetric subgraphs. We conducted extensive performance stud- ies using 22 large graphs, and confirmed that DviCL is much more efficient and robust than the state-of-the-art. Combinatorial objects and complex structures are often modeled as graphs in many applications, including social networks and so- cial media [29], expert networks [20], bioinformatics [38, 39], and mathematical chemistry [6]. Among many graph problems, graph isomorphism is a problem to determine whether two graphs are iso- morphic [32]. The graph isomorphism is an important issue in practice since it has been used for deduplication and retrieval in dealing with a collection of graphs, and is an important issue in theory due to its relationship to the concept of NP-completeness. A closely related graph problem is automorphism (symmetry) de- tection, where an isomorphism between two graphs is a bijection between their vertex sets that preserves adjacency, and an automor- phism (symmetry) is an isomorphism from a graph to itself. Au- tomorphism detection is also important in various graph problems. On one hand, by automorphism, from a global viewpoint, two ver- tices (or subgraphs) are equivalent in the sense that the entire graph remains unchanged if one is replaced by the other. Therefore, with automorphism, certain finding over a single vertex (or a subgraph) can be applied to all other automorphic vertices (or subgraphs). On the other hand, as symmetries of combinatorial objects are known to complicate algorithms, detecting and discarding symmetric sub- problems can reduce the scale of the original problems. There are many applications of graph isomorphism and automor- phism detection, including database indexing [31], network model [24, 36], network measurement [35], network simplification [35], and social network anonymization [34]. (a) Database Indexing: Given a large database of graphs (e.g., chemical compounds), it as- signs every graph with a certificate such that two graphs are isomor- phic iff they share the same certificate [31]. (b) Network Model: It studies the automorphism groups of a wide variety of real-world networks and finds that real graphs are richly symmetric [24]. In [36], it claims that similar linkage patterns are the underlying in- gredient responsible for the emergence of symmetry in complex networks. (c) Network Measurement: In [37], it proposes a struc- ture entropy based on automorphism partition to precisely quan- tify the structural heterogeneity of networks, and finds that struc- tural heterogeneity is strongly negatively correlated to symmetry of real graphs. (d) Network Simplification: In [35], it utilizes inher- ent network symmetry to collapse all redundant information from a network, resulting in a coarse graining, known as "quotient", and claims that they preserve various key function properties such as complexity (heterogeneity and hub vertices) and communication (diameter and mean geodesic distance), although quotients can be substantially smaller than the original graphs. (e) Social Network Anonymization: In [34], it proposes a k-symmetry model to mod- ify a naively-anonymized network such that for any vertex in the network, there exist at least k−1 structurally equivalent counter- parts, protecting against re-identification under any potential struc- tural knowledge about a target. Below, we discuss how graph au- tomorphism is used for influence maximization (IM) [1, 8, 17, 28], and discuss symmetric subgraph matching (SSM) by graph auto- morphism and other SSM applications [10, 19, 21]. Influence maximization (IM) is widely studied in social networks and social media to select a set S of k seeds s.t. the expected value of the spread of the influence σ(S) is maximized. In the litera- ture, almost all work in IM find a single S with the maximum influence. With graph automorphism, we can possibly find a set S = {S1, S2, · · · } where each Si has the same max influence as S while contains some different vertices, and we are able to select one Si in S that satisfies some additional criteria (e.g., attributes on ver- tices in a seed set and distribution of such seed vertices). To show such possibilities, we compute IM by one of the best performing algorithms, PMC [28], under the IC model as reported by [1], over a large number of datasets (Table 1) using the parameters following [1], where the probability to influence one from another is treated as constant. We conduct testing to select a set of k seeds, for k = 10 and k = 100. We find that there are 8.82E+15 and 2.93E+15 can- didate seed sets for wikivote when k = 10 and k = 100, respec- tively, and the numbers for Orkut are 4 and 2.9E+10, respectively. To find S for S found by IM can be processed as a special case of symmetric subgraph matching (SSM), which we discuss below. Symmetric subgraph matching (SSM), we study in this paper, is closely related to subgraph matching (or subgraph isomorphism). Given a query graph q and a data graph G, by subgraph matching, it finds all subgraphs g in G that are isomorphic to q. By SSM, q is required to be a subgraph that exists in G and any g returned should be symmetric to q in G, i.e., there is at least one automor- phism γ of G having g = qγ . Note that all subgraphs discussed here are induced. The applications of SSM include software pla- giarism, program maintenance and compiler optimizations [10, 19, 21], where an intermediate program representation, called the pro- gram dependence graph (PDG) is constructed for both control and data dependencies for each operation in a program. In the literature, to check if two graphs are isomorphic, the most practical approach is canonical labeling, by which a graph is rela- beled in such a way that two graphs are isomorphic iff their canon- ical labeling are the same. Since the seminal work [25, 26] by McKay in 1981, nauty has become a standard for canonical label- ing and has been incorporated into several mathematical software tools such as GAP [14] and MAGMA [7]. Other canonical labeling approaches, such as bliss [15, 16] and traces [30], address pos- sible shortcomings of nauty closely following nauty's ideas. De- spite their high performance, these approaches face difficulties in handling today's massive graphs. As shown in our experimental studies (Table 5), nauty fails in all but one datasets, traces fails in nearly half datasets, and bliss is inefficient in most datasets. Due to the lack of efficient canonical labeling algorithms for massive graphs, to the best of our knowledge, merely have any algorithms incorporated graph isomorphism or graph automorphism. In this work, we propose a novel efficient canonical labeling al- gorithm for massive graphs. We observe that the state-of-the-art algorithms (e.g., nauty [25, 26], traces [30] and bliss [15, 16]) dis- cover the canonical labeling following "individualization-refinement" schema. These algorithms enumerate all possible permutations and select the minimum Gγ as the canonical labeling. Here, graph G as well as the permutated Gγ can be represented as elements from a totally ordered set, for instance, G (Gγ) can be represented by its sorted edge list. At first glance, choosing the minimum Gγ as the target is probably the most efficient for branch-and-bound algo- rithms. However, the minimum Gγ is not always the best choice for any graph G. For instance, if all vertices in G can be easily distin- guished, the permutation γ based on sorting is a better choice. Our main idea is to divide the given graph into a set of subgraphs satis- fying that (1) two isomorphic graphs G and G′ will be divided into two sorted subgraph sets {g1, . . . , gk} and {g′1, . . . , g′k}, such that gi is isomorphic to g′i for 1 ≤ i ≤ k; (2) the canonical labeling of the original graph G can be easily obtained by canonical labeling of the subgraphs. Note that canonical labeling of each subgraph gi can be defined arbitrarily, not limited to the minimum gγ i . As a consequence, our approach returns the k-th minimum Gγ as the canonical labeling. Note that k is not fixed for all graphs, and we do not need to know what the k value is when computing the canoni- cal labeling. Applying such idea to each subgraph gi, our approach DviCL follows divide-and-conquer paradigm and constructs a tree index, called AutoTree AT . Here, a tree node in AT corresponds to a subgraph gi of G, and contains its canonical labeling as well as automorphism group. The root corresponds to G. By the AutoTree, we can easily detect symmetric vertices and subgraphs in G. Take the maximum clique as an example. Given a graph G, for a maximum clique q found [22], we can efficiently identify 4 candidate maximum cliques in Google and 16 candidate maximum cliques in LiveJournal (Table 1) using the AutoTree con- structed, respectively. Algorithm SSM-AT for symmetric subgraph matching is given in Section 6.4. For k-symmetry [34], with Au- toTree, each subtree of root can be duplicated to have at least k − 1 symmetric siblings. As a consequence, each vertex has at least k−1 automorphic counterparts in the reconstructed graph. The main contributions of our work are summarized below. First, we propose a novel canonical labeling algorithm DviCL following the divide-and-conquer paradigm. DviCL can efficiently discover the canonical labeling and the automorphism group for massive graphs. Second, we construct an AutoTree for a graph G which provides an explicit view of the symmetric structure in G in addi- tion to the automorphism group and canonical labeling. Such Au- toTree can also be used to solve symmetric subgraph matching and social network anonymization. Third, we conduct extensive exper- imental studies to show the efficiency and robustness of DviCL. The preliminaries and the problem statement are given in Sec- tion 2. We discuss related works in Section 3, and review the pre- vious algorithms in Section 4. We give an overview in Section 5, and discuss the algorithms in Section 6. We conduct comprehen- sive experimental studies and report our findings in Section 7. We conclude this paper in Section 8. 2. PROBLEM DEFINITION In this paper, we discuss our approach on an undirected graph G = (V, E) without self-loops or multiple edges, where V and E denote the sets of vertices and edges of G, respectively. We use n and m to denote the numbers of vertices and edges of G, respectively, i.e., n = V and m = E. For a vertex u ∈ V , the neighbor set of u is denoted as N (u) = {v (u, v) ∈ E}, and the degree of u is denoted as d(u) = N (u). In the following, we discuss some concepts and notations using an example graph G shown in Fig. 1(a). Permutation: A permutation of V , denoted as γ, is a bijection function from V to itself. We use vγ to denote the image of v ∈ V under a permutation γ. By a permutation γ to a graph G, it per- mutes vertices in V of G and produces a graph Gγ = (V γ , Eγ ), here V γ = V and Eγ = {(uγ , vγ )(u, v) ∈ E}. Following the convention used in the literature, we use the cycle notation In a permutation γ, (v1, v2, . . . , vk) to represent permutations. means vγ k = v1. For i = vi+1 for 1 ≤ i ≤ k − 1 and vγ 0 3 1 2 7 4 5 6 0 [0,1,2,3,4,5,6 7] 1 2 3 4 [6,5,4 2 3,1 0 7] [6,5,4 3 0,2 1 7] // // [2,0,1,3 6,5 4 7] 6 // 5 // 2 4 5 [6,5 4 2 3,1 0 7] [6,4 5 2 3,1 0 7] 6 // 4 0 [6,5 4 3 0,2 1 7] [2 3,1 0 6,5 4 7] [0 3,1 2 6,5 4 7] 5 6 4 5 1 1 [6 5 4 2 3,1 0 7] [5 6 4 2 3,1 0 7] [6 4 5 2 3,1 0 7] [6 5 4 3 0,2 1 7] [2 3 1 0 6,5 4 7] 1 3 (5,6) (4,5) [6 5 4 2 3 1 0 7] [6 5 4 2 1 3 0 7] 0 5 [6 5 4 3 2 0 1 7] [2 3 1 0 6 5 4 7] [0 3 1 2 6,5 4 7] (1,3) (0,1)(2,3) (0,3,1,2)(4,6) (a) An example graph (b) Backtrack search tree T (G, π) by bliss for the graph in Fig. 1(a) Figure 1: An example graph and a backtrack search tree by bliss simplicity, we may only show permutation for a subset of ver- tices using the cycle notation, with the assumption that other ver- tices will be permuted to themselves. Consider the graph G in Fig. 1(a), the permutation γ1 = (4, 5, 6) is to relabel 4 as 5, 5 as 6, and 6 as 4, where all the other vertices are permutated to them- selves. It produces a graph Gγ1 = (V, Eγ1 ), where Eγ1 = E. For the same graph G, the permutation γ2 = (0, 1) relabels 0 as 1 and 1 as 0, and produces Gγ2 = (V, Eγ2 ), where Eγ2 = E ∪ {(0, 2), (1, 3)} \ {(0, 3), (1, 2)}. All permutations of V (n! for n = V ) consist of a symmetry group with the permutation composition as the group operation, denoted as Sn. Automorphism: An automorphism of a graph G = (V, E) is a permutation γ (∈ Sn) that preserves G's edge relation, i.e., Gγ = G, or equivalently, Eγ = E. In graph G (Fig. 1(a)), γ1 = (4, 5, 6) is an automorphism of G whereas γ2 = (0, 1) is not. Similarly, all automorphisms of G, consist of an automorphism group with per- mutation composition as the group operation, denoted as Aut(G) (⊆ Sn). Each graph G has a trivial automorphism, called identity, de- noted as ι, that maps every vertex to itself. For two distinct ver- tices u and v in G, if there is an automorphism γ mapping u to v, i.e., uγ = v, we say vertices u and v are automorphic equiva- lent, denoted as u ∼ v. For instance, automorphism γ1 = (4, 5, 6) indicates that vertices 4, 5 and 6 are automorphic equivalent. Structural equivalent: In a graph G, two distinct vertices u and v are structural equivalent if they have the same neighbor set, i.e., N (u) = N (v). Obviously, if two vertices are structural equiva- lent, they must be automorphic equivalent, while the converse does not always hold. For G in Fig. 1(a), vertices 0 and 2 are structural equivalent since they have the same neighbor set. Similarly, ver- tices 1 and 3 are also structural equivalent. Vertices 4 and 5 are not structural equivalent, although they are automorphic equivalent. Isomorphism: Two graphs G1 and G2 are isomorphic iff there 1 = G2, and we use G1 ∼= G2 to exists a permutation γ s.t., Gγ denote G1 and G2 are isomorphic. To check whether two graphs are isomorphic, canonical label- ing (also known as canonical representative or canonical form) is used. A canonical labeling is a function, C, to relabel all vertices of a graph G, such that C(G) ∼= G, and two graphs, G and G′, are isomorphic iff C(G) = C(G′). A common technique used in the literature to determine a canonical labeling is by coloring. Be- low, we introduce coloring, colored graph, and canonical labeling by coloring. In brief, to get a canonical labeling for a graph G, we first get a colored graph (G, π) for given color π, and we get the canonical labeling for (G, π) using coloring to prune unneces- sary candidates. The canonical labeling obtained for (G, π) is the canonical labeling for the original graph G. Coloring: A coloring π = [V1V2 . . . Vk] is a disjoint partition of V in which the order of subsets matters. We use Π(V ), or simply Π, to denote the set of all colorings of V . Here, a subset Vi is called a cell of the coloring, and all vertices in Vi have the same color. In other words, π is to associate each v ∈ V with the color π(v), where π(v) ← P0<j<i Vj if v ∈ Vi. A cell is called a singleton cell if it contains only one vertex, otherwise it is called a non-singleton cell. π is called an unit coloring if there is only one partition of V (k = 1) and π is called a discrete coloring if there are n partitions for a graph with n vertices (k = n). π is equitable with respect to graph G, if for every v1, v2 ∈ Vi (1 ≤ i ≤ k), v1 and v2 have the same number of neighbors in Vj (1 ≤ j ≤ k), for any i and j. Consider G in Fig. 1(a). The coloring π1 = [0, 1, 2, 3, 4, 5, 67] has two cells, V1 and V2, where V2 = {7} is a singleton cell. For every two vertices in V1 = {0, 1, 2, 3, 4, 5, 6}, they have 2 neighbors in V1, and 1 neighbor in V2. In a similar way, π2 = [0, 1, 2, 34, 5, 67] is also equitable. However, π3 = [0, 1, 2, 34, 5, 6, 7] is not equitable, since not every two vertices in the cell of V2 = {4, 5, 6, 7} have the same number of neighbors in V1 even though they have the same number of neighbors in V2. For example, 7 in V2 has 4 neighbors in cell V1 but the other vertices in V2 have no neighbors in V1. A coloring π = [V1V2 . . . Vk] represents Π1≤i≤kVi! permu- tations. A discrete coloring corresponds to a single permutation π : x → π(x), where every vertex has a unique color. For in- stance, the discrete coloring [03214657] corresponds to the permutation (1, 3)(5, 6). The concept of equitable coloring is pro- posed to reduce the search space for discovering automorphism group and canonical labeling. A partial order is defined over col- orings. Given two colorings π and π′, π′ is finer than or equal to π, denoted as π′ (cid:22) π, if each cell of π′ is a subset of a cell 6= π, then π′ is finer than π, denoted of π. as π′ ≺ π. For instance, π2 = [0, 1, 2, 34, 5, 67] is finer than π1 = [0, 1, 2, 3, 4, 5, 67]. A permutation γ can be applied to a coloring π, denoted as πγ, which results in a coloring such that πγ (v) = π(vγ) for any v ∈ V . Suppose π3 = [0, 1, 23, 4, 5, 67] and γ3 = (1, 3)(5, 7), πγ3 If π′ (cid:22) π and π′ 3 = [0, 2, 31, 4, 6, 75]. An orbit coloring is a coloring where each cell contains all ver- tices that are automorphic. Colored graph: A colored graph is a pair (G, π), where π is a coloring of G. Note that coloring π be used to represent la- bels/attributes on vertices s.t. two vertices are in the same cell iff they share the same labels/attributes. A graph G itself is a colored graph (G, π) where the coloring π is unit, or in other words, all ver- tices have the same color. Similarly, two colored graphs (G1, π1) and (G2, π2) are isomorphic if there exists a permutation γ s.t. (G1, π1) = (G2, π2)γ , denoted as (G1, π1) ∼= (G2, π2). Note that (G, π)γ = (Gγ , πγ). Canonical labeling (by coloring): Let G and Π denote the set of graphs and colorings, a canonical representative (or a canoni- cal form) is a function C : G × Π → G × Π, such that for any colored graph (G, π) ∈ G × Π and permutation γ of V , the fol- lowing two properties are satisfied. First, the canonical represen- tative of a colored graph is isomorphic to the colored graph, i.e., C(G, π) ∼= (G, π). Second, the canonical representative of a col- ored graph by γ, (Gγ , πγ) = (G, π)γ, is the same as the canonical representative of graph (G, π), i.e., C(Gγ , πγ ) = C(G, π), mean- ing that the canonical representatives of two isomorphic graphs are the same. There are many candidates for canonical representa- tive. A canonical labeling of (G, π) is a permutation γ∗ satisfying (Gγ∗ ) = C(G, π). For simplicity, we use canonical label- ing to represent canonical representative. For G in Fig. 1(a), if π is a unit coloring and canonical labeling function C is defined as C(G, π) = (Gγ∗ ) where γ∗ = argminγ∈Sn Eγ , then γ∗ = (0, 7)(1, 5)(2, 4)(3, 6) is a candidate. , πγ∗ , πγ∗ We summarize the discussions on coloring, permutation, auto- morphism, and canonical labeling. A coloring represents a set of permutations and a discrete coloring corresponds to a single per- mutation. A permutation γ is a relabeling of the vertices such that γ on a colored graph (G, π) results in a relabeled graph (G, π)γ that is isomorphic to (G, π). All permutations in Sn are classi- fied into several subgroups s.t. all permutations in each subgroup generate the same relabeled colored graph. A signature of the cor- responding subgroup is the relabeled colored graph, (G, π)γ. The subgroup with the signature (G, π)γ = (G, π) forms the automor- phism group, in which each permutation is an automorphism. By defining a total order among such signatures, a permutation with the minimum signature is the canonical labeling. 3. RELATED WORKS Graph isomorphism is an equivalence relation on graphs by which all graphs are grouped into equivalence classes. By graph isomor- phism, it allows us to distinguish graph properties inherent to the structures of graphs from properties associated with graph repre- sentations: graph drawings, graph labeling, data structures, etc. From the theoretical viewpoint, the graph isomorphism prob- lem is one of few standard problems in computational complex- ity theory belonging to NP, but unknown if it belongs to either of P or NP-complete. It is one of only two, out of 12 total, prob- lems listed in [12] whose complexity remains unresolved. NP- completeness is considered unlikely since it would imply collapse of the polynomial-time hierarchy [13]. The best currently accepted theoretical algorithm is due to [2, 4], whose time complexity is eO(√nlogn). Although the graph isomorphism problem is not gen- erally known to be in P or NP-complete, they can be solved in poly- nomial time for special classes of graphs, for instance, graphs of bounded degree [23], bounded genus [11, 27], bounded tree-width [5], and with high probability for random graphs [3]. However, most of these algorithms are unlikely to be useful in practice. In practice, the first practical algorithm to canonically labeling graphs with hundreds of vertices and graphs with large automor- phism groups was nauty [25, 26], developed by McKay. Observing that the set of symmetries of a graph forms a group under func- tional composition, nauty integrates group-theoretical techniques and utilizes automorphisms discovered to prune the search tree. Motivated by nauty, a number of algorithms, such as bliss [15, 16] and traces [30] are proposed to address possible shortcomings of nauty's search tree, which we will discuss in Section 4. Another algorithm worth noting is saucy [9]. The data structures and algo- rithms in saucy take advantage of both the sparsity of input graphs and the sparsity of their symmetries to attain scalability. Different from nauty-based canonical labeling algorithms, saucy only finds graph symmetries, precisely, a generating set of the automorphism group. All algorithms mentioned above are difficult to deal with real-world massive graphs, and the search tree used are for pruning purposes not for answering SSM queries. 4. THE PREVIOUS ALGORITHMS In this section, we outline the main ideas of the three state-of- the-art algorithms, namely, nauty, bliss and traces, that enumer- ate all permutations in the symmetry group Sn, add all permuta- tions γ satisfying (Gγ, πγ) = (G, π) into the automorphism group Aut(G, π) and choose the colored graph (Gγ , πγ ) with the mini- mum value under some specific function as the canonical labeling. Such enumeration of permutations in Sn is done by a search tree. In the search tree, each node corresponds to a coloring, and each edge is established by individualizing a vertex in a non-singleton cell in the coloring of the parent node. Here, individualizing a ver- tex means to assign this vertex a unique color. For instance, in- dividualizing vertex 4 in π = [0, 1, 2, 34, 5, 67] results in π′ = [0, 1, 2, 345, 67]. The coloring of the child node is definitely finer than the coloring of the parent node, and each leaf node corre- sponds to a discrete coloring, which is equivalent to a permutation in Sn. By the search tree, each permutation is enumerated once and only once, which implies that the whole search tree contains as many as n! leaf nodes. We give the details on the search tree. The search tree, de- noted as T (G, π), is a rooted label tree with labels on both nodes and edges. Here, a node-label is a coloring by individualizing from the root to the node concerned, and an edge-label is a ver- tex in G that is individualized from the node-label of the parent node to the node-label of the child node in T (G, π). Fig. 1(b) shows the search tree T (G, π) constructed by bliss for the graph G (Fig. 1(a)), in which a node in T (G, π) is shown as x where x is a node identifier. The node identifiers indicate the order they are traversed. In Fig. 1(b), the root node is labeled by an equitable coloring [0, 1, 2, 3, 4, 5, 67], which has 7 child nodes by individu- alizing one of the vertices in the non-singleton cell. The node 1 is a child node of the root by individualizing vertex 0 in G. Here, the individualization of 0 is represented as the edge-label of the edge from the root to the node 1 . The node-label of 1 represents a finer equitable coloring [6, 5, 421, 307] comparing the color- ing of [0, 1, 2, 3, 4, 5, 67] at the root. In T (G, π), the edge-label sequence (or simply sequence) from the root to a node shows the order of individualization. In Fig. 1(b), node 3 is associated with a sequence 045 and has a node-label coloring [65423, 107]. In the following, we also use (G, π, ν) to identify a node in the search tree by the sequence ν from the root to the node. The node 4 is the leftmost leaf node in the search tree with a discrete col- oring π0 = [65423107] whose corresponding permutation is γ0 = (0, 6)(1, 5)(2, 3, 4). In T (G, π), the leftmost leaf node (cor- responds to a colored graph (Gγ0 , πγ0 ) with some specific permu- tation γ0) is taken as a reference node. Any automorphism, γ′γ−1 0 , will be discovered when traversing a leaf node with permutation γ′ having (Gγ0 , πγ0 ) = (Gγ′ denotes the inverse element of γ0. Reconsider Fig. 1(b), by taking the leftmost leaf node 4 as a reference node, an automorphism (1, 3) is discovered ). Here, γ−1 , πγ′ 0 when traversing the node 5 . The three state-of-the-art algorithms, nauty, bliss and traces ex- ploit three main techniques, namely, refinement function R, target cell selector T and node invariant φ to construct the search tree T (G, π) and prune fruitless subtrees in T (G, π). In brief, the re- finement function R aims at pruning subtrees whose leaf nodes cannot result in any automorphisms with the reference node, the target cell selector T selects a non-singleton cell from a coloring at a node for its children in the search tree, and the node invariant φ is designed to prune subtrees where no new automorphisms can be found or the canonical labeling cannot exist. The refinement function R: For every tree node with a sequence ν (the edge-label sequence from the root to the node), the refine- ment function, R : G × Π × V ∗ → Π, specifies an equitable coloring corresponding to ν and π. In specific, the refinement is done by giving the vertices in the sequence unique colors and then inferring a coloring of the other vertices s.t., the resulting color- ing is equitable. Mathematically, a refinement function is a func- tion, R : G × Π × V ∗ → Π, such that for any G ∈ G, π ∈ Π and ν ∈ V ∗, we have the following. (i) R(G, π, ν) (cid:22) π. (ii) If v ∈ ν, then {v} is a cell of R(G, π, ν). (iii) For any γ ∈ Sn, R(Gγ , πγ, ν γ) = R(G, π, ν)γ. Revisit the search tree T (G, π) in Fig. 1(b). Refinement func- tion R refines the empty sequence and the unit coloring of the root node by differentiating vertex 7 from the others in G (Fig. 1(a)). The node 1 can be identified by a sequence 0 from the root. R(G, π, 0) individualizes vertex 0 from the coloring associated with root node, i.e., [0, 1, 2, 3, 4, 5, 67], resulting in [1, 2, 3, 4, 5, 6 07], which is further refined to an equitable coloring [6, 5, 421, 3 07]. Target cell selector T : For a tree node (G, π, ν) that is identified by a sequence ν, the target cell selector T : G × Π × V ∗ → 2V se- lects a non-singleton cell from the coloring by R(G, π, ν) to spec- ify its children, where each child node is generated by individu- alizing a vertex in the non-singleton cell selected, if the coloring R(G, π, ν) is not discrete. Mathematically, a target cell selector is a function, T : G × Π × V ∗ → 2V , such that for any G ∈ G, π ∈ Π and ν ∈ V ∗, the following three holds. (i) If R(G, π, ν) is discrete, then T (G, π, ν) = ∅. (ii) If R(G, π, ν) is not discrete, then T (G, π, ν) is a non-singleton cell of R(G, π, ν). (iii) For any γ ∈ Sn, T (Gγ, πγ , ν γ) = T (G, π, ν)γ . The choice of a target cell has a significantly effect on the shape of the search tree. Some [26] uses the first smallest non-singleton cell, while some others [18] use the first non-singleton cell regard- less of the size. In Fig. 1(b), we follow the suggestion of [18]. For instance, target cell selector T on the node 1 chooses the first non-singleton cell {6, 5, 4}, and generates three child nodes ( 2 , 7 , and 9 ) by individualizing vertices 4,5, and 6, respectively. Node invariant φ: It assigns each node in the search tree with an element from a totally ordered set, and φ is designed with the following properties: (a) φ is isomorphic-invariant on tree nodes, i.e., φ(Gγ , πγ, ν γ) = φ(G, π, ν) for any γ ∈ Sn; (b) φ acts as a certificate on leaf nodes, i.e., two leaf nodes share the same value under φ iff they are isomorphic; (c) φ retains the partial ordering between two subtrees rooted at the same level. Mathematically, let Ω be some totally ordered set. A node invariant is a function, φ : G × Π × V ∗ → Ω, such that for any π ∈ Π, G ∈ G, and distinct ν, ν′ ∈ T (G, π0), we have the following. (i) If ν = ν′, and φ(G, π, ν) < φ(G, π, ν′), then for every leaf ν1 ∈ T (G, π, ν) and leaf ν′1 ∈ T (G, π, ν′), we have φ(G, π, ν1) < φ(G, π, ν′1); (ii) If π = R(G, π, ν) and π′ = R(G, π, ν′) are discrete, then φ(G, π, ν) = φ(G, π, ν′) ⇔ Gπ = Gπ′ ; (iii) For any γ ∈ Sn, we have φ(Gγ , πγ, ν γ ) = φ(G, π, ν). By the node invariant φ, three (1) PA(ν, ν′) removes types of pruning operations are possible. subtree T (G, π, ν′) that contains no automorphisms with the ref- erence node, when φ(G, π, ν′) on some node ν′ does not equal to φ(G, π, ν). Here, ν is the node on the leftmost path having ν = ν′. (2) PB(ν, ν′) removes subtree T (G, π, ν′) that does not contain the canonical labeling, when φ(G, π, ν′) < φ(G, π, ν). Here ν is the node on the path whose leaf node is chosen as the cur- rent canonical labeling, and ν = ν′. (3) PC(ν, ν′) removes subtree T (G, π, ν′) that contains no new automorphisms, when ν′ = ν γ where γ is an automorphism discovered or can be com- posed by discovered automorphisms. 5. AN OVERVIEW OF OUR APPROACH Previous algorithms enumerate all permutations and select the minimum (G, π)γ as the canonical labeling C(G, π). There are two things. The first is that the algorithms use the minimum (G, π)γ as the target to prune candidates during the enumeration, and the second is that the minimum (G, π)γ is used for any graph. From a different angle, we consider if we can use the k-th minimum (G, π)γ as the canonical labeling C(G, π), where the minimum (G, π)γ is a special case when k = 1. Recall that (G, π)γ is repre- sented as the sorted edge list, in other words, all possible (G, π)γ form a totally ordered set. We observe that there is no need to fix a certain k for any graph or even to know what the k value is when computing the canonical labeling. We only need to en- sure that there is such a k value based on which two graphs are isomorphic iff their corresponding k-th minimum (G, π)γ are the same. Different from previous algorithms which are designed to prune candidates, we take a divide-and-conquer approach to parti- tion a graph. We discuss an axis by which a graph is divided, the AutoTree AT (G, π) and its construction. Axis: We partition (G, π) into a set of vertex disjoint subgraphs, {(g1, π1), (g2, π2), ..., (gk, πk)}. We ensure that by the partition, all automorphisms in (G, π) can be composed by the automor- phisms in every (gi, πi), and the isomorphisms between subgraphs (gi, πi) and (gj, πj). In other words, the automorphisms in (gi, πi) and the isomorphisms between (gi, πi) and (gj, πj) form a gener- ating set for the automorphism group of (G, π). We then compute canonical labeling C(G, π) by C(gi, πi) for every (gi, πi). We discuss how to partition (G, π) into subgraphs by symmetry according to an axis, which satisfies the requirements mentioned above. Note that two subgraphs, (gi, πi) , (gj, πj), are symmet- ric in (G, π), if there is an automorphism γ that maps (gi, πi) to (gj, πj ). The axis by γ includes all vertices v having vγ = v, since they are invariant under γ. We partition (G, π) by such an axis. By removing vertices in the axis and their adjacent edges from (G, π), (gi, πi) and (gj, πj) are connected components, and all symme- tries by γ in (G, π) are preserved due to the fact that (gi, πi) and (gj, πj ) are isomorphic. We preserve all symmetries by any such automorphism γ with an equitable coloring. Recall that, in an eq- uitable coloring, vertices in singleton cells cannot be automorphic to any other vertices, and thus such vertices, as the common part of all axes, preserve the symmetries of Aut(G, π). The AutoTree AT (G, π): We illustrate the main idea of our ap- proach in Fig. 2. First, graph (G, π) is divided into a set of vertex disjoint colored subgraphs {(g1, π1), . . . , (gk, πk)}. Such parti- tion can be achieved by common symmetries given in an equitable coloring obtained by a refinement function R on (G, π). Giving canonical labeling C(gi, πi) for every subgraph (gi, πi), all sub- graphs can be sorted and divided into subsets, where subgraphs having the same canonical labeling are grouped in a subset (di- vided by vertical dash lines in Fig. 2). The subgraphs in the same subset are symmetric in (G, π) since they are partitioned by sym- metry. For instance, in Fig. 2, suppose two subgraphs (g1, π1) and (g2, π2) are with the same canonical labeling, then they are in the same subset. They are isomorphic, and there is a permuta- tion γ12 such that (g1, π1)γ12 = (g2, π2) by definition. In gen- divide (g1, π1) (G, π) C (G, π) conquer 0,1,2,3,4,5,6,7 ,2,37] , π=[4,5,6 ! ,2,3,7]→ [ , =[4,5,6, # $ " , % & ,2,6,5,3,4,7] (g2, π2) . . . (gk, πk) C (gi, πi) canonical labeling on each subgraph (gi, πi) {4,5,6} π=[4,5,6] =[4,5,6]→ [  , 0 1 ,2] { ,  , π=[ ,2,3}   =[ ,    ,2,3] ,2,3]→ [6,5,3,4] {7} π=[7] =7→ 7  . . . . . . (g1, π1)γ12 = (g2, π2) (g1, π1)γ13 = (g3, π3) (gi, πi)γij = (gj , πj ) (gk, πk)γk = (gk, πk) Figure 2: An Overview of Our Approach 5 7 4 6 3 2 1 8 9 10 11 12 13 g1 3 2 4 6 5 7 9 8 10 12 11 13 g 1 g2 g3 g11 g12 4 5 2 3 6 7 g13 g31 g32 8 9 10 11 g33 12 13 3 2 g112 5 4 7 6 g132 9 8 11 10 13 12 g332 Figure 3: An AutoTree Example eral, for (gi, πi)γij = (gj, πj ), such γij will derive an automor- phism in Aut(G, π), and in addition, every automorphism in a sin- gle subgraph (gi, πi) is also an automorphism in Aut(G, π). In such sense, we have a generating set of the automorphism group Aut(G, π), i.e., Aut(G, π) is completely preserved. Note that, two graphs, (G, π) and (G′, π′), are isomorphic, iff they gener- ate the same sorted subgraph sets, resulting in the same canonical labeling. As a consequence, DviCL discovers the k-th minimum (G, π)γ as the canonical labeling. Canonical labeling of each subgraph (gi, πi) can be obtained in the same manner, which results in a tree index. In the tree, each node is associated with automorphism group and canonical label- ing and child nodes of each non-leaf node are sorted by canonical labeling. We call such an ordered tree an AutoTree, denoted as AT (G, π), for given graph (G, π). Such an AutoTree benefits to discovering the automorphism group Aut(G, π) and the canonical labeling C(G, π). We explain key points of AutoTree AT (g, π), using an exam- ple in Fig. 3. Here, we assume the coloring π associated with the colored graph (g, π) is equitable, and show how the AutoTree is constructed for such a colored graph. As shown in Fig. 3, the entire graph g is represented by the root. There are 3 colors in the equi- table coloring. Here, two vertices have the same color if they are in the same cell in π. First, vertex 1 in the singleton cell in π acts as an axis for g and partitions g into three subgraphs g1 (left), g2 (right), and g3 (mid), where g2 consists of a single vertex 1. Sec- ond, we construct sub-AutoTree rooted at g1. We find that there is a complete subgraph, g′ ⊆ g1, over all vertices {2, 4, 6} that have the same color. We observe that the automorphism group of g1 will not be affected without the edges in g′, and further divide g1 into g11 (left), g12 (mid), and g13 (right). Here, we consider the set of {2, 4, 6} as an additional axis (a11) for g1. Third, consider g11 as an example, it will be divided into another 2 subgraphs, each In AT (g, π), two contains a vertex having unique color in g11. vertices, 2 and 6 are automorphic, because 2 ∈ g112, 6 ∈ g132, and g112 and g132 are isomorphic and symmetric according to the axis a11. Similarly, 2 and 12 are automorphic, because 2 ∈ g112, {4} {5} {6} π=[6] π=[4] =6→ =4→  π=[5] =5→      [2 3, ]  [23 ] 3 3 ,3) ]  [2  (   [3 ,2 ]    ] [32   , ) (2,3)(   2 / / 3 / / ' , ( ) *=[ ,2,3]→ [3,2, , ] + * Figure 4: AutoTree for the graph G in Fig. 1(a). 12 ∈ g332, and g112 and g332 are isomorphic and are symmetric according to the axis a1. We discuss the key property of AutoTree AT (G, π). For any two automorphic vertices u and u′, the axes recursively divide, u and u′, into a series of subgraph pairs ((g1, g′1), (g2, g′2), . . . , (gk, g′k)) such that (1) g1 ⊃ g2 ⊃ . . . ⊃ gk and g′1 ⊃ g′2 ⊃ . . . ⊃ g′k, (2) (gk, πk) and (g′k, π′k) are leaf nodes in AT (G, π), and (3) gi and g′i are isomorphic and symmetric in G. For instance, the two automorphic vertices, 2 and 12, in Fig. 3 are divided into subgraph pairs ((g1, g3), (g11, g33), (g112, g332)). In other words, for any two automorphic vertices, they must be in two leaf nodes in Au- toTree, whose corresponding subgraphs have the same canonical labeling and are symmetric. As a consequence, automorphisms be- tween vertices can be detected by comparing canonical labeling of leaf nodes containing these vertices. As can be observed in the experiments, (1) most vertices in G are in singleton cells, (2) non- singleton leaf nodes in AT (G, π) are small in size. By AT (G, π), automorphisms between vertices can be efficiently detected. It is worth mentioning that, in the existing approaches, determin- ing whether two vertices are automorphic need to compare a set of permutations. The generation of canonical labeling C(G, π), as we will discuss, can be done in a bottom-up manner, where the canonical labeling of a non-leaf node in AT (G, π) can be done by combining canonical labeling of its child nodes, which significantly reduces the cost. AT (G, π) is a sorted tree. In AT (G, π), the root represents (G, π), and every node represents a subgraph (g, πg). Here, g is a subgraph of G induced by V (g) and πg is the projection of π on V (g). Note that πg(v) = π(v) for any v ∈ g and any g ⊂ G. Each node (g, πg) in AT (G, π) is associated with canonical labeling C(g, πg), or equivalently, a permutation γg generating C(g, πg), i.e., (g, πg)γg = C(g, πg). For any singleton subgraph g = {v}, we define C(g, πg) = (vγg , vγg ) = (π(v), π(v)). Permutation γg can be generated for a node (g, πg) in three cases: (a) γg is trivially obtained for a singleton leaf node, (b) γg is generated with canon- ical labeling achieved by any existing algorithm (e.g., nauty, bliss and traces) for a non-singleton leaf node, and (c) γg is generated by combining all canonical labeling of g's children. The canonical labeling of the root node is the one of the given graph. Automor- phisms of (G, π) can be discovered between two nodes with the same canonical labeling and automorphisms of each subgraph. Fig. 4 shows the AutoTree AT (G, π) constructed for the graph G in Fig. 1(a). A node in AT (G, π) represents a subgraph (g, πg), by its V (g) together with its permutation γg. Consider the three leaf nodes (singletons) from the left (i.e., the three one-vertex sub- graphs), {4}, {5}, and {6}, with coloring πg = [4], πg = [5], πg = [6], respectively. The permutations for the three subgraphs are, γ = 4 → 0, γ = 5 → 0, and γ = 6 → 0. Vertices 4, 5 and 6 are mutually automorphic since these three leaf nodes have the same canonical labeling. The permutation for the parent of the three singletons is γ = [4, 5, 6] → [0, 1, 2] by combining the (g, πg) gi vsk gj g1 vs1 . . . g2 g . . . . . . . . . (vs1, [vs1]) (vsk, [vsk]) (g1, πg1) (gj, πgj) AT (g, πg) Figure 5: The Overview of Algorithm DivideI Vi (g, πg) Vj Vk Vl g (g1, πg1) . . . (gk, πgk) AT (g, πg) Figure 6: The Overview of Algorithm DivideS canonical labeling of the three singletons. Subgraph {4, 5, 6} does not have symmetric counterparts since there exist no other nodes having the same canonical labeling. The 4th leaf node from the left is non-singleton, since it cannot be further divided. We use bliss to obtain its permutation, in dashed rectangle. In an AutoTree, the permutation γg for (g, πg), is done as fol- lows. First, vγg = π(v) is generated for a singleton leaf node with {v}. For example, for the 2nd leaf node from the left of {5} in Fig. 4, π(5) = 0 which indicates the cell in the coloring where 5 exists. Second, γg is generated by an existing algorithm for a non-singleton node. For example, the 4th leaf node from the left in Fig. 4 is a non-singleton. its permutation γg is obtained by a back- track search tree constructed using an existing algorithm. Third, γg for a non-leaf node is determined by those of its child nodes. The AutoTree AT (G, π) Construction: We design an algorithm DviCLto construct an AutoTree AT (G, π) by divide-and-conquer. In the divide phase, DviCL divides (G, π) into a set of subgraphs (gi, πgi ), each consists of a child node of (G, π) in AT (G, π). DviCLrecursively construct AutoTree AT (gi, πgi ) rooted at (gi, πgi ). In the combine phase, DviCL determines the canonical labeling of (G, π) by the canonical labeling of its child nodes (gi, πgi ). In the divide phase, two algorithms are used to divide (g, πg), namely, Di- videI and DivideS, by removing edges in g that have no influence in determining the automorphism group and the canonical labeling of (g, πg). Consider Fig. 3. DivideI is to remove edges by finding sin- gleton cells in πg (e.g., the vertex 1 in g), whereas DivideS is to re- move edges by complete subgraphs or complete bipartite subgraphs (e.g., the complete subgraph in g1). A leaf node in AT (G, π) is a node that cannot by divided by DivideI or DivideS. An overview is shown in Fig. 5 for DivideI. In Fig. 5, the left shows a tree node (g, πg) where vertices vsi are in singleton cells in πg, and the right shows the child nodes constructed for (g, πg) by DivideI. Isolating singleton cells in πg is to remove dashed edges in g and partition g into a set of connected components gi. (g, πg) → [ (vsi , [vsi ]) ∪ [ (gj , πgj ) i j Here, each (vsi , [vsi ]) represents a one-vertex colored subgraph as a result from a singleton cell in πg, and each (gj, πgj ) is a con- nected component of (g, πg). An overview is shown in Fig. 6 for DivideS. In Fig. 6, the left shows a subgraph (g, πg) whose vertices are in 4 different cells, Vi, Vj , Vk, and Vl. The right shows the child nodes constructed for the node that represents (g, πg) by DivideS. DivideS removes edges 0 1 7 4 5 6 1,2,4,5,6,7 0,1! 4,5,6! 7! 0! 1! 4! 5! 6! (a) simplified graph Gs (b) AutoTree of Gs Figure 7: Simplified graph and its AutoTree 0,1,2,3,4,5,6,7 π=[4,5,60,1,2,37] γ=[0,1,2,3,4,5,6,7]→ [3,5,4,6,0,1,2,7] {4,5,6} π=[4,5,6] γ =[4,5,6]→ [0,1,2] {0,1,2,3} π=[0,1,2,3] γ =[0,1,2,3] → [3,5,4,6] {7} π=[7] γ=7→ 7 {4} π=[4] γ=4→ 0 {5} π=[5] γ=5→ 0 {6} π=[6] γ=6→ 0 {0} π=[0] γ 0→ 3 = {2} {1} π=[1] π=[2] γ=1→ 3 γ=2→ 3 {3} π=[3] γ=3→ 3 Figure 8: AutoTree by DviCL for G (Fig. 1(a)) on Fig. 7(a)(b). for 2 cases. First, DivideS removes all edges from the induced sub- graph over the cell Vi if it is a complete subgraph. Second, DivideS removes all edges between 2 different colors Vj and Vk if there is a complete bipartite subgraph between all vertices in Vj and all vertices in Vk. Removing such edges does not affect the automor- phism group Aut(g, πg). By removing such edges, (g, πg) can be possibly divided into several disconnected components (gi, πi). We have (g, πg) → [ (gk, πgk ) k In the combine phase, DviCL generates the permutation γg for the node (g, πg) in AutoTree. Note that permutation γg is the one that produces the canonical labeling C(g, πg). First, consider the base case when (g, πg) is a leaf node in AT (G, π). If (g, πg) is a singleton leaf node (e.g., g = {v}), we define gγg = π(v). If (g, πg) is a non-singleton leaf node, we obtain γg by CombineCL. Here, CombineCL first applies an existing approach to generate a canonical labeling γ∗ for (g, πg). With γ∗, vertices sharing the same color, i.e., in the same cell in πg, are differentiated by the ordering introduced by γ∗. Second, consider the case when (g, πg) is a non-leaf node. CombineST exploits the canonical labeling of the child nodes of (g, πg) (i.e., γgi and (gi, πgi )γgi of (gi, πgi )) to determine an ordering that can differentiate vertices in the same cell in πg, and obtains γg in a similar manner. 6. THE NEW APPROACH We give our DviCL algorithm in Algorithm 1. Given a colored graph (G, π), DviCLconstructs an AutoTree AT (G, π) for (G, π) (Line 4). Note that the canonical labeling C(G, π) at the root of AT (G, π) acts as the canonical labeling of the given graph. In DviCL, the given coloring π is refined to be equitable by a re- finement function R, for instance, Weisfeiler-Lehman algorithm [33], and is further exploited to assign each vertex v with color π(v) (Line 1-2). Then, DviCL applies procedure cl to construct AutoTree AT (G, π)(Line 3). We discuss Procedure cl in detail. Procedure cl constructs AT (g, πg) rooted at (g, πg), for a col- ored subgraph (g, πg) ⊂ (G, π) following the divide-and-conquer paradigm. AT (g, πg) is initialized with root node (g, πg) (Line 6). cl divides (g, πg) into a set of subgraphs (gi, πgi ), each consists of a child node of (g, πg), utilizing Algorithm DivideI (Algorithm 2) and Algorithm DivideS (Algorithm 3) (Line 11-12). cl recursively Algorithm 1: DviCL (G, π) 1 π = [V1V2 . . . Vk] ←R (G, π); 2 π(v) ← P0<j<i Vj for each v ∈ V ; 3 AT (G, π) ← cl(G, π); 4 return AT (G, π); 5 Procedure cl (g, πg ) 6 initialize AT (g, πg) with root (g, πg ); 7 if g = {v} then 8 vγg ← π(v), C(g, πg ) ← (vγg , vγg ); return AT (g, πg); 9 if neither DivideI nor DivideS can disconnect (g, πg) then 10 C(g, πg) ← CombineCL(g, πg); return AT (g, πg ); 11 S1≤i≤k(gi, πgi ) ← DivideI(g, πg)(DivideS(g, πg )); 12 construct tree edges ((g, πg), (gi, πgi )) for all i; 13 for i from 1 to k do 14 AT (gi, πgi ) ← cl(gi, πgi ); 15 C(g, πg ) ← CombineST (g, πg); 16 return AT (g, πg); constructs subtrees AT (gi, πgi ) rooted at each (gi, πgi ) (Line 13- 14) and identifies the canonical labeling C(g, πg) for the root node (g, πg) utilizing Algorithm CombineST (Algorithm 5) (Line 15). The base cases occur when either g contains a single vertex (Line 7- 8) or (g, πg) cannot be disconnected by DivideI or DivideS (Line 9- 10). For the former case, obtaining C(g, πg) is trivial. For the latter case, C(g, πg) can be achieved by applying Algorithm CombineCL (Algorithm 4), which exploits the canonical labeling γ∗ by existing algorithms like bliss. 6.1 Optimized by Structural Equivalence Recall that structural equivalent vertices must be automorphic equivalent. Such property can be applied to simplify (G, π) and improve the performance of DviCL. Specifically, vertices in V are partitioned into a number of structural equivalent subsets. Vertices in each non-singleton subset S are simplified by retaining only one vertex v in the subset, and the colored graph (G, π) is simplified accordingly. When constructing AutoTree, the leaf node containing v is extended either by adding a number of sibling leaf nodes, each contains a vertex in S if the leaf node containing v is singleton, or by adding vertices in S to the subgraph of the leaf node otherwise. Fig. 7(a) and Fig. 7(b) illustrate the simplified graph Gs of the graph G in Fig. 1(a) and its AutoTree, respectively. For simplicity, AutoTree in Fig. 7(b) contains the tree structure without any infor- mation such as canonical labeling on each tree node. In the example graph G, shown in Fig. 1(a), there are two non-singleton structural equivalent subsets, {0, 2} and {1, 3}. Therefore, in the simplified graph Gs, shown in Fig. 7(a), vertices 2 and 3 along with their ad- jacent edges are removed. Based on the simplified graph and its AutoTree AT (Gs, πs), the AutoTree AT (G, π) of (G, π) is con- structed by extending leaf nodes containing vertices 0 and 1, shown in Fig. 8. It is worth noting that different approaches, or even dif- ferent implementations, can generate different canonical labeling, while each approach, or implementation, will generate the same canonical labeling for isomorphic graphs. For instance, the canon- ical labeling of the root nodes in Fig. 4 and Fig. 8 are different. 6.2 DivideI and DivideS We show DivideI and DivideS in Algorithm 2 and Algorithm 3. Both algorithms take a colored graph (g, πg) as input and attempt to divide (g, πg) into a set of subgraphs (gi, πgi ). DivideI isolates each singleton cell {vsi } in πg as a colored subgraph (vsi , [vsi ]) of (g, πg) (Line 2-3). Each connected component gi due to the iso- lation results in a colored subgraph (gi, πgi ) of (g, πg) (Line 4-5). On the other hand, DivideS divides (g, πg) based on Theorem 6.2 (Line 1-6). Similar to DivideI, each connected component gi re- sults in a colored subgraph (gi, πgi ) of (g, πg) (Line 8-9). We first discuss properties of refinement function R. In DviCL, we apply Weisfeiler-Lehman algorithm [33] as the refinement func- tion R. As proved by [33], only vertices in the same cell in the resulting equitable coloring π can probably be automorphic equiv- alent. In DviCL, only the coloring π for G is achieved by the re- finement function R, all the other colorings, i.e., πg for subgraphs g, are obtained by projecting π on V (g). The following theorem proves the equivalence between projecting π on V (g) and applying R on (g, πg). Theorem 6.1: πg, the projection of π on V (g) by DivideI and DivideS, inherits the properties of π. Specifically, (1) only vertices in the same cell in πg can be automorphic equivalent. (2) πg is equitable with respect to g. Proof Sketch: The first property can be proved trivially. We focus on the second property, and prove the claim based on the mathe- matical induction. Assume g is a connected component in g′ that emerges due to either DivideI or DivideS, and πg′ satisfies the sec- ond property. In either case, the edges removed are those between two cells in πg′ . Then for any two vertices in the same cell in πg, they either retain all neighbors or remove all neighbors in any cell in πg′ , i.e., πg is equitable with respect to g. ✷ Lemma 6.1: Given a graph (g, πg). For any cell Vi ∈ πg , if the subgraph induced by Vi is a clique, removing edges among vertices in Vi, i.e., Ei = {(u, v)u, v ∈ Vi, u 6= v} ∩ E(g), will not influence the automorphism group of (g, πg). Proof Sketch: : Let g′ denote the graph after removing edges Ei from g, and Aut(g′, πg′ ) denote its automorphism group. By The- orem 6.1, πg′ = πg. For simplicity, we will use πg for πg′ below. Consider automorphisms γ ∈ Aut(g, πg), γ′ ∈ Aut(g′, πg). We prove γ ∈ Aut(g′, πg) and γ′ ∈ Aut(g, πg), respectively. We prove γ′ ∈ Aut(g, πg), and γ ∈ Aut(g′, πg) can be proved in the similar manner. Consider v ∈ Vi. Since v and vγ′ are au- tomorphic, v and vγ′ ∈ Vi, implying that V γ′ i = Vi. As a consequence, for any edge (u, v) ∈ Ei, (uγ′ , vγ′ = (g, πg), i.e., γ′ ∈ Aut(g, πg). ✷ must be in the same cell in πg, i.e., vγ′ ) ∈ Ei. Therefore, (g, πg)γ′ Lemma 6.2: Given a colored graph (g, πg). For any two cells Vi and Vj in πg, let Eij denotes the edges between Vi and Vj, i.e., Eij = {(u, v)u ∈ Vi, v ∈ Vj} ∩ E(g). If the subgraph (Vi ∪ Vj, Eij) is a complete bipartite graph, removing edges Eij will not influence the automorphism group of (g, πg). Proof Sketch: The proof is similar to that of Lemma 6.1. ✷ Note that DivideI is a special case of Lemma 6.2. Theorem 6.2: Given a colored graph (g, πg), applying DivideI and DivideS on (g, πg) retains the automorphism group of (g, πg). In other words, removing the following two classes of edges will not influence Aut(g, πg): (1) edges among vertices in Vi, i.e., Ei = {(u, v)u, v ∈ Vi, u 6= v} ∩ E(g), if the subgraph induced by Vi is a clique. (2) edges between Vi and Vj, i.e., Eij = {(u, v)u ∈ Vi, v ∈ Vj} ∩ E(g), if the subgraph (Vi ∪ Vj, Eij ) is a complete bipartite graph. Proof Sketch: It can be proved by Lemma 6.1, Lemma 6.2. Lemma 6.3: Given two isomorphic graphs (G, π) and (G′, π′), if they are simplified by either DivideI or DivideS, then the remain- ing graphs are isomorphic. Specifically, each remaining graph can be partitioned into a subgraph set, i.e., {(gi, πgi )} for (G, π) and Algorithm 2: DivideI (g, πg) 1 S ← ∅; 2 for each singleton cell {vsi } in πg do 3 S ← S ∪ {(vsi , [vsi ])}; g ← g \ vsi ; 4 for each connected component gi in g do 5 S ← S ∪ {(gi, πgi )}; 6 return S; Algorithm 3: DivideS (g, πg) 1 for each cell Vi ∈ πg do 2 if Vi induces a clique then 3 remove all edges between vertices in Vi; 4 for any two distinct cells Vi and Vj in πg do 5 if edges between Vi and Vj consist a complete bipartite graph then 6 remove all edges between Vi and Vj ; 7 S ← ∅; 8 for each connected component gi in g after removing edges do 9 S ← S ∪ {(gi, πgi )}; 10 return S; {(g′i, π′gi )} for (G′, π′), and the two subgraph sets can be sorted such that (gi, πgi ) ∼= (g′i, π′gi ). Proof Sketch: Similar to the proof of automorphism retainment, i.e., Lemma 6.1 and Lemma 6.2, we prove that each edge set re- moval will retain any isomorphism between (G, π) and (G′, π′). Without loss of generality, we prove the case when removing edges Ei from (G, π) and removing E′i from (G′, π′) simultaneously. Here, Ei and E′i are the same as defined in Lemma 6.1, and ver- tices in the corresponding cells Vi and V ′i have the same color. Such property can be easily extended to prove Lemma 6.3. Let (g, πg) and (g′, πg′ ) denote the remaining graph after re- moving Ei from (G, π) and E′i on (G, π) and (G′, π′), respec- tively. Here, πg = π and πg′ = π′ by Theorem 6.1. Denote γ as an arbitrary isomorphism between (G, π) and (G′, π′), i.e., (G, π)γ = (G′, π′). We prove that (g, π)γ = (g′, π′). First, by isomorphism, we have V γ i = V ′i . Since both Vi and V ′i induce complete subgraphs, for any edge (u, v) ∈ Ei, (u, v)γ ∈ E′i. As a consequence, Eγ i , π′), (g′, πg′ ) = ((G′ \ E′i, π′) we have (g, π)γ = (g′, π′). i = E′i. Second, since (g, π)γ = ((Gγ \ Eγ ✷ Theorem 6.3: Given two isomorphic graphs (G, π), (G′, π′), the structure of AT (G, π) and AT (G′, π′) are the same. Here, the structure of an AutoTree is a tree without any labels. Proof Sketch: The proof can be constructed by mathematical in- duction on each tree node with Lemma 6.3. ✷ Time complexity of DivideI and DivideS: Easy to see, the time complexity of DivideI is O(m) as each component of DivideI costs O(m). We focus on the time complexity of DivideS. Recall that a coloring π is equitable with respected to a graph G, if for all vertices vi, v2 ∈ Vi, they have the same number of neighbors in Vj. Such property can be utilized to accelerate DivideS. Specifically, DivideS assigns each cell Vi with a vector, where each element maintains the number of neighbors of each vertex v ∈ Vi in Vj. Then checking if Vi consists a clique is equivalent to checking if the i-th element in the vector equals Vi − 1. Checking whether Vi and Vj consists a biclique is equivalent to checking if the j-th element in the vector equals Vj. Therefore, each component of DivideS also costs O(m), i.e., DivideS costs O(m). 6.3 CombineCL and CombineST Algorithm 4: CombineCL (g, πg) 1 γ ∗ ← bliss(g, πg ); 2 for each vertex v ∈ V (g) do 3 4 C(g, πg ) = (g, πg)γg ; 5 return C(g, πg ); vγg ← π(v) + {uπg(u) = πg(v), uγ∗ < vγ∗ }; We discuss algorithms CombineCL and CombineST, which gen- erate the canonical labeling C(g, πg) for the input colored graph (g, πg). CombineCL, shown in Algorithm 4, generates γg for a non-singleton leaf node exploiting the canonical labeling γ∗ ob- tained by existing approaches (Line 1). γ∗ introduces a total or- der among vertices in the same cell in πg, resulting in the canoni- cal labeling γg, along with vertex color π(v) due to π (Line 2-3). Canonical labeling C(g, πg) can be trivially obtained as (g, πg)γg (Line 4). On the other hand, CombineST, shown in Algorithm 5, generates γg for a non-leaf node by combining canonical labeling of its child nodes (gi, πgi ). Canonical labeling C(gi, πgi ) intro- duces a total order between vertices in different subgraphs (Line 1- 2) and canonical labeling γgi introduce a total order among ver- tices in the same subgraph (gi, πgi ) (Line 3). These two orders determines a total order between vertices in the same cell in πg, resulting in the canonical labeling γg for (g, πg) (Line 4-5), in the similar manner. Canonical labeling C(g, πg) can be obtained by as (g, πg)γg (Line 6). Lemma 6.4: For two leaf nodes (g1, πg1 ) and (g2, πg2 ) in Au- toTree, if they are symmetric in (G, π), i.e., these is a permutation γ ∈ Aut(G, π) such that (g1, πg1 )γ = (g2, πg2 ), C(g1, πg1 ) = C(g2, πg2 ) by Algorithm CombineCL. Proof Sketch: The proof is trivial when (g1, πg1 ) and (g2, πg2 ) are singleton, since the vertices are in the same cell in π. We focus on the case when (g1, πg1 ) and (g2, πg2 ) are non- singleton. For ease of discussion, we assume vertices in g1 and g2 are relabeled from 1 to k, respectively. Here k = V (g1) = V (g2). Since (g1, πg1 ) and (g2, πg2 ) are symmetric in (G, π), they are isomorphic, i.e., (g1, πg1 )γ1 = (g2, πg2 )γ2 . Here, γ1 and γ2 are the corresponding permutations by bliss. Let v ∈ g1 and u ∈ g2 be two vertices having vγ1 = uγ2 , we prove vγg1 = uγg2 . Let v1 ∈ g1 and u1 ∈ g2 be two vertices having vγ1 1 . If π(v1) = π(v) and vγ1 1 < vγ1 , then π(u1) = π(v1) = π(v) = π(u) and uγ2 1 < uγ2 . The reverse also holds, implying that v1 and u1 have the same influence on vγg1 and uγg2 . If π(v1) 6= π(v), then π(u1) 6= π(u), i.e., v1 and u1 have no, which is also the same, influence on vγg1 and uγg2 . As a consequence, vγg1 = uγg2 , i.e., C(g1, πg1 ) = C(g2, πg2 ). ✷ 1 = uγ2 Lemma 6.5: For two non-leaf nodes (g1, πg1 ) and (g2, πg2 ), if (g1, πg1 ) and (g2, πg2 ) are symmetric in (G, π), i.e., these is a permutation γ ∈ Aut(G, π) such that (g1, πg1 )γ = (g2, πg2 ), then C(g1, πg1 ) = C(g2, πg2 ) by CombineST. Proof Sketch: We prove the base case, i.e., child nodes of (g1, πg1 ) and (g2, πg2 ) are leaf nodes, the other cases can be proved by math- ematical induction. First, by Lemma 6.3, child nodes of (g1, πg1 ) and (g2, πg2 ) can be sorted such that each pair (gi, πgi ) and (gj, πgj ) are isomor- phic. Second, by Lemma 6.4, C(gi, πgi ) = C(gj, πgj ). Then for any vertex pairs v ∈ gi and u ∈ gj having vγgi = uγgj , we have (1) there are the same number of subgraph pair (g′i, π′gi ) and (g′j, π′gj ) that are isomorphic and share the same canonical la- beling with (gi, πgi ) and (gj, πgj ), while (g′i, π′gi ) is sorted be- fore (gi, πgi ) and (g′j, π′gj ) is sorted before (gj, πgj ); (2) there are the same number of vertex pairs v′ ∈ gi and u′ ∈ gj with Algorithm 5: CombineST (g, πg) 1 sort child nodes (gi, πgi ) of (g, πg) in non-descending order of C(gi, πgi ); 2 sort vertices in each cell in πg , s.t., u is before v if u ∈ gi, v ∈ gj , i < j; 3 sort vertices in each cell in πgi , s.t., u is before v if uγgi < vγgi ; 4 for each vertex v ∈ V (g) do 5 6 C(g, πg ) = (g, πg)γg ; 7 return C(g, πg ); vγg ← π(v) + {uπg(u) = πg (v), u is before v}; v′γgi = u′γgj , having v′γgi < vγgi and u′γgj < uγgj . As a con- sequence, vγg1 = uγg2 , in other words, C(g1, πg1 ) = C(g2, πg2 ). The following theorem gives the correctness of DviCL. Theorem 6.4: Given two graphs (G1, π1) and (G2, π2), they are isomorphic iff the canonical labeling C(G1, π1) and C(G2, π2) by DviCL satisfy C(G1, π1) = C(G2, π2). Proof Sketch: We construct an auxiliary graph G containing G1, G2 and an vertex u connecting to every vertex in G1 and G2. Easy to see, u is distinct from any other vertices in G, and G1 and G2 are symmetric in G. Therefore, the root of the AutoTree AT (G, π) has three child nodes, (u, πu), (G1, π1) and (G2, π2). According to Lemma 6.4 and Lemma 6.5, C(G1, π1) = C(G2, π2). ✷ Theorem 6.5: In (G, π), if two vertices are symmetric, they are in two leaf nodes in AT (G, π) sharing the same canonical labeling. Proof Sketch: It can be proved by Lemma 6.4 and Lemma 6.5, since a leaf node cannot be isomorphic to a non-leaf node. ✷ We revisit previous algorithms, e.g., nauty, bliss, traces as well as our approach DviCL. As mentioned, previous algorithms enu- merate all possible permutations and select the minimum (G, π)γ as the canonical labeling. On the other hand, our approach DviCL constructs a tree index AutoTree AT that recursively partitions the given graph (G, π) into subgraphs. By partition, DviCL exploits properties of (s, πs) that enable canonical labeling computation from combining without enumeration. Canonical labeling for each node (s, πs) in AT (G, π) is either the minimum (s, πs)γ , for a leaf node, or the k-th minimum (s, πs)γ obtained by combining the canonical labeling of child nodes, for a non-leaf node. Note that for different tree nodes, the k values are different. As a conse- quence, DviCL returns the k-th minimum (G, π)γ as the canonical labeling and ensures that k is the same for isomorphic graphs. Time complexity of CombineCL and CombineST: For CombineCL, easy to see, the most time-consuming parts are invoking existing canonical labeling algorithms to generate γ∗ (Line 1) and generat- ing the canonical labeling C(G, π) (Line 4). Therefore, the time complexity of CombineCL is O(X + E(g)ln(E(g))) where X is the time complexity of canonical labeling algorithms. Similarly, the most time-consuming parts of CombineSTare determining total order between different child nodes of (g, πg) (Line 1) and gener- ating the canonical labeling (Line 6), since the other parts either cost O(V (g)log(V (g))) or cost O(V (g)). Therefore, the time complexity of CombineST is O(E(g)ln(E(g))). 6.4 Symmetric Subgraph Matching We propose Algorithm SSM-AT (Algorithm 6) for SSM, fol- lowing divide-and-conquer paradigm. SSM-AT is designed by the properties of AutoTree AT . Specifically, two tree nodes sharing the same canonical labeling implies that the two corresponding sub- graphs in G are symmetric, and one isomorphism between these two subgraphs can be easily obtained. SSM-AT (G, q, AT (g)) finds all symmetric subgraphs of q in the subtree of AT that rooted at g, i.e., in a subgraph g of G. SSM-AT first finds the minimal subgraph, a tree node nq in AT , that contains q (Line 1). Then, Algorithm 6: SSM-AT (G, q, AT (g)) 1 find tree node nq ∈ AT (g) with max depth that contains q; 2 if nq is a leaf node or nq = q then 3 S ← SM(nq , q) or S ← nq ; 4 else 5 6 7 8 9 10 11 12 divide q into subgraphs {q1, . . . , qk}, contained in children {n1, . . . , nk} of nq ; for each (qi, ni) do Si ← SSM-AT (G, qi, AT (ni)); for each child nj of nq that shares the same canonical labeling with ni do Sj ← Si γij ; S ← ∅; for each {n1′ , . . . , nk′ } do S ← S ∪ S1′ × . . . × Sk′ ; 13 for each nq′ sharing the same canonical labeling with nq do 14 S ← S ∪ S γ qq′ ; 15 return S; symmetric subgraphs of q in nq can be extended to those in sub- graphs nq′ that are symmetric to nq by an isomorphism γqq′ from nq to nq′ , consisting the symmetric subgraphs of q in G (Line 13- 14). Symmetric subgraphs of q in nq can be found by divide-and- conquer. The basic cases occur when nq is a leaf node or nq = q, then an existing subgraph isomorphism algorithm SM can be ap- plied or returns nq as the result (Line 2-3). Otherwise, q is divided into subgraphs {q1, . . . , qk} by the children of nq, where qi is con- tained in ni (Line 5). Symmetric subgraphs of qi in ni can be found recursively by SSM-AT (G, qi, AT (ni)), and mapped to those in nj that is symmetric to ni (Line 6-9). As a consequence, each sym- metric subgraph of q in nq can be composed by mosaic subgraphs in {n1′ , . . . , nk′ } where ni′ is ni or is a sibling node symmetric to ni (Line 11-12). Since the majority of leaf nodes are singleton, SSM-AT is efficient and robust. On the other hand, existing sub- graph matching algorithms have several drawbacks. (1) the time complexity is not bounded. (2) they will find much more candi- date matchings than the result. (3) the verification of symmetry between a matching g and the query graph q is not trivial. (4) there is no guarantee to find all symmetric subgraph matchings. Example 6.1: Consider the AutoTree AT in Fig. 3, where all the leaf nodes are singleton, and leaf nodes with the same canonical labeling correspond to the vertices with the same color. Consider an SSM query q, 3-2-6, on g. We find symmetric subgraphs of q in g1, and those in g3 can be extended by isomorphism γ = (3, 9)(2, 8)(5, 11)(4, 10)(7, 13)(6, 12). Symmetric subgraphs of q in g1 are divided into q1, 3-2, in g11 and q2, 6 in g13. S1 = g11, which can be extended to S2 = g12 and S3 = g13. Those for q2 can be obtained similarly. As a consequence, symmetric subgraphs of q in g1 can be composed as S = {3-2-4, 3-2-6, 5-4-2, 5-4-6, 7-6-2, 7-6-4}. Those in g3 can be obtained by S γ. 7. EXPERIMENTAL STUDIES We conducted extensive experimental studies using 22 large real graphs and 9 benchmark graphs to test how DviCL improves nauty [26], bliss [15], and traces [30], using their latest distributed ver- sions, i.e., nauty-2.6r10, traces-2.6r10 (http://pallini.di.uniroma1.it/) and bliss-0.73 (http://www.tcs.hut.fi/Software/bliss/index.html). Below, we use DviCL+X to indicate that X is used to compute canonical labeling for non-singleton leaf nodes in AT . We have DviCL+n, DviCL+b and DviCL+t, where n, b, and t are for nauty, bliss, and traces. All algorithms are implemented in C++ and com- plied by gcc 4.8.2, and tested on machine with 3.40GHz Intel Core i7-4770 CPU, 32GB RAM and running Linux. Time unit used is second and we set time limit as 2 hours. Graph Amazon BerkStan Epinions Gnutella Google LiveJournal NotreDame Pokec Slashdot0811 Slashdot0902 Stanford WikiTalk wikivote Youtube Orkut BuzzNet Delicious Digg Flixster Foursquare Friendster Lastfm V 403,394 685,230 75,879 62,586 875,713 4,036,538 325,729 1,632,803 77,360 82,168 281,903 2,394,385 7,115 1,138,499 3,072,627 101,163 536,408 771,229 2,523,386 639,014 5,689,498 1,191,812 E 2,443,408 6,649,470 405,740 147,892 4,322,051 34,681,189 1,090,108 22,301,964 469,180 504,229 1,992,636 4,659,563 100,762 2,990,443 117,185,083 2,763,066 1,366,136 5,907,413 7,918,801 3,214,986 14,067,887 4,519,340 6.69 dmax davg 2,752 12.11 84,230 19.41 3,044 10.69 4.73 9.87 95 6,332 396,034 387,172 53,067 46,098 525,232 14,815 17.18 3,703,527 10,721 115,038 14,854 27.32 1,586,176 61,457 65,264 168,967 553,199 5,789 28,754 684,471 33,313 11.19 3,042,918 77,588 64,289 54.63 263,961 5.09 445,181 17,643 15.32 6.28 1,047,509 364,447 4.95 2,135,136 675,962 7.58 2,539 12.13 2,552 12.27 38,625 14.14 3.89 1,065 28.32 5.25 4,423 5,150 100,029 3,216 1,474 106,218 10.06 cells singleton Graph V (AT ) singleton non-singleton avg size depth 390,706 316,162 45,552 38,216 424,563 3,518,490 89,791 1,561,671 56,219 59,384 133,992 498,161 5,283 585,349 3,028,961 76,758 221,669 400,605 928,445 315,108 1,973,584 609,605 Amazon BerkStan Epinions Gnutella Google LiveJournal NotreDame Pokec Slashdot0811 Slashdot0902 Stanford WikiTalk wikivote Youtube Orkut BuzzNet Delicious Digg Flixster Foursquare Friendster Lastfm 407,032 709,702 76,919 62,598 910,617 4,064,750 328,259 1,633,602 77,809 82,661 291,006 2,398,843 7,139 1,161,551 3,073,414 101,179 537,831 771,879 2,524,659 639,015 5,689,609 1,192,094 403,388 681,680 75,879 62,586 874,908 4,036,533 318,204 1,632,803 77,360 82,168 279,912 2,394,385 7,115 1,138,499 3,072,627 101,163 533,507 771,229 2,523,386 639,014 5,689,498 1,191,812 1 118 0 0 71 1 46 0 0 0 55 0 0 0 0 0 339 0 0 0 0 0 6 30.08 0 0 11.34 5 163.59 0 0 0 36.2 0 0 0 0 0 8.56 0 0 0 0 0 3 5 3 2 5 3 5 3 3 3 5 3 2 3 3 2 3 3 3 1 3 2 Table 1: Summarization of real graphs Table 3: The Structure of AutoTrees of real graphs Graph ag2-49 cfi-200 difp-21-0-wal-rcr fpga11-20-uns-rcr grid-w-3-20 had-256 mz-aug-50 pg2-49 s3-3-3-10 V 4,851 2,000 16,927 5,100 8,000 1,024 1,000 4,902 12,974 E 120,050 3,000 44,188 9,240 24,000 131,584 2,300 122,550 23,798 dmax 50 3 1,526 21 6 257 6 50 26 davg 49.49 3 5.22 3.62 6 257 4.6 50 3.67 cells singleton 2 800 16,215 3,531 1 1 250 1 9,146 0 0 15,755 2,418 0 0 0 0 5,318 Table 2: Summarization of benchmark graphs Datasets: The 22 large real-world graphs include social networks (Epinions, LiveJournal, Pokec, Slashdot0811, Slashdot0902, wikiv- ote, Youtube, Orkut, BuzzNet, Delicious, Digg, Flixster, Foursquare and Friendster), web graphs (BerkStan, Google, NotreDame, Stan- ford), a peer-to-peer network (Gnutella), a product co-purchasing network (Amazon), a communication network (WikiTalk), and a music website (lastfm). All these datasets are available online. The detailed information of the real-world datasets are summarized in Table 1, where, for each graph, the 2nd and 3rd columns show the numbers of vertices and edges1, the 4th and 5th columns show the sizes of max degree and average degree of each graph, and the 6th and 7th columns show the numbers of cells and singleton cells in the orbit coloring of each graph. As shown in Table 1, the majority of the cells in the orbit coloring are singleton cells. This prop- erty makes DivideI and DivideS effective since the partition (The- orem 6.2) are more likely to happen when subgraphs get smaller. For the 9 benchmark graphs, we select the largest one in each family of graphs used in bliss collection [15]. Detail descriptions of each benchmark graph can be found in [15]. Similarly, summa- rization are given in Table 2. Below, we first demonstrate the structure of AutoTrees constructed, and use the observations made to explain the efficiency and perfor- mance of our approaches DviCL+X, which will be confirmed when we illustrate the performance of DviCL+X and X. The Structure of AutoTree: Table 3 demonstrates the structure of AutoTrees constructed for real graphs by DviCL+X. Note that for the same graph, three DviCL+X algorithms construct the same Au- toTree. The 2nd, 3rd, 4th columns show the numbers of total nodes, 1for each dataset, we remove directions if included and delete all self-loops and multi-edges if exist. Graph V (AT ) singleton non-singleton avg size depth ag2-49 cfi-200 difp-21-0-wal-rcr fpga11-20-uns-rcr grid-w-3-20 had-256 mz-aug-50 pg2-49 s3-3-3-10 1 1 16,928 2,441 1 1 1 1 12,999 0 0 16,927 2,418 0 0 0 0 12,974 1 1 0 22 1 1 1 1 0 4,851 2,000 0 121.91 8,000 1,024 1,000 4,902 0 0 0 1 1 0 0 0 0 2 Table 4: The Structure of AutoTrees of benchmark graphs singleton leaf nodes, non-singleton leaf nodes in AutoTree, respec- tively. The 5th column shows the average size (number of vertices) of each non-singleton leaf node and the 6th column shows the depth of AutoTree. Several interesting observations can be made. First, in 15 out of 22 datasets, AutoTree contains only singleton leaf nodes. In these datasets, there is no need to exploit existing approaches to discover automorphism group and canonical labeling, i.e., the three DviCL+X algorithms on these graphs can be done in polyno- mial time and the performances are almost the same. The AutoTree AT (G, π), the automorphism group Aut(G, π) and the canonical labeling C(G, π) can be achieved with only an equitable coloring at the root in AutoTree. Second, in the remaining 7 datasets that contain non-singleton leaf nodes, there are only a small number of non-singleton leaf nodes and these non-singleton leaf nodes are of small sizes. Transferring the problem of discovering the canoni- cal labeling for a massive graph to finding the canonical labeling for a few small subgraphs improves the efficiency and robustness significantly. This observation also explains the phenomenon that all DviCL+X consume almost the same amount of memory in each datasets: AutoTree is the most space-consuming structure when there are only a few small non-singleton leaf nodes. Third, Au- toTrees are usually with low depths. Since both DivideI and Di- videS cost O(ms) for a graph with ms edges and all subgraphs in the same depth in AutoTree are vertex disjoint, constructing AT (G, π) costs O(m). Similarly, with the canonical labeling of all non-singleton leaf nodes, achieving the canonical labeling for all tree nodes in AT (G, π) only costs O(m · lnm). Forth, compar- ing the 3rd column in Table 3 and the 7th column in Table 1, Di- videI and DivideS can further partition some automorphic vertices into singleton leaf nodes in AutoTree, which can further improve the efficiency. Table 4 demonstrates the structure of AutoTrees constructed for Graph Amazon BerkStan Epinions Gnutella Google LiveJournal NotreDame Pokec Slashdot0811 Slashdot0902 Stanford WikiTalk wikivote Youtube Orkut BuzzNet Delicious Digg Flixster Foursquare Friendster Lastfm nauty DviCL+n traces DviCL+t bliss DviCL+b time memory - - - - - - - - - - - - 40.27 - - - - - - - - - - - - - - - - - - - - - 9.5 - - - - - - - - - time 1.19 2.59 0.14 0.09 2.7 15.95 9.28 6.9 0.15 0.16 1.34 4.04 0.02 2.33 25.76 0.48 0.94 1.83 4.26 1.32 9.12 2.2 memory 280.18 575.16 56.11 31.26 553.42 3,051.48 221.98 1,549.93 57.62 59.04 193.79 1,548.52 6.43 769.7 5,182.92 145.05 384 565.94 1,626.57 449 3,337.77 847.63 time - - 0.43 0.01 - - - - 0.13 0.05 - - 0.01 - 166.07 0.07 2,546.96 5.61 1.05 0.28 24.71 0.6 memory - - 84.66 34.73 65.87 58.86 6.52 10,856 135.22 11,535.7 1,012 1,518 407.55 5,607.55 713.47 time 1.18 2.6 0.14 0.09 2.69 15.92 0.84 6.8 0.15 0.15 1.36 3.93 0.02 2.3 25.47 0.45 0.89 1.82 4.2 1.37 8.87 2.24 memory 280.21 575.17 55.12 31.26 553.49 3,051.77 221.98 1,549.94 57.62 59.04 193.79 1,548.55 6.42 769.76 5,182.93 145.05 384 565.94 1,626.57 449 3,337.77 847.63 time 10.88 3,510.85 7.75 4.78 - - 509.32 293.5 5.34 5.93 311.04 - 0.07 4,623.3 340.45 268.16 1,302.8 2,088.65 - 1,457.7 - 5,264.58 memory 158.22 694.52 35.86 28.19 - - 202.65 767.44 33.94 38.36 203.99 - 3.8 517.62 2,224.17 69.69 293.54 418.79 - 340.51 - 553.64 time 1.18 2.62 0.14 0.08 2.69 15.94 0.96 6.85 0.15 0.16 1.35 3.96 0.02 2.33 25.86 0.45 0.95 1.82 4.17 1.36 8.95 2.23 memory 280.23 575.26 56.12 31.26 553.55 3,051.96 222 1,549.95 57.62 59.04 193.89 1,548.58 6.42 773.65 5,182.94 145.05 384 565.94 1,626.57 449 3,337.77 847.63 Table 5: Performance of nauty, DviCL+n, traces, DviCL+t, bliss, and DviCL+b on real-world networks maximum clique Graph number 610 Amazon 4 BerkStan 18 Epinions 16 Gnutella 8 Google LiveJournal 589,824 1 NotreDame 6 Pokec 52 Slashdot0811 104 Slashdot0902 Stanford 10 141 WikiTalk 23 wikivote 2 Youtube 20 Orkut 12 BuzzNet Delicious 9 192 Digg 752 Flixster 8 Foursquare 120 Friendster Lastfm 330 cluster max 3 1 1 1 4 16 1 1 1 1 2 1 1 1 1 1 1 1 1 1 1 1 584 4 18 16 2 36,864 1 6 52 104 6 141 23 2 20 12 9 192 752 8 120 330 number 3,986,507 64,690,980 1,624,481 2,024 13,391,903 177,820,130 8,910,005 32,557,458 551,724 602,588 11,329,473 9,203,518 608,389 3,056,537 - 30,919,848 487,972 62,710,797 7,897,122 21,651,003 8,722,131 3,946,212 triangle cluster 3,837,711 10,487,015 1,622,749 2,017 6,325,254 158,645,941 2,629,782 32,545,137 550,747 600,239 4,041,344 9,165,115 608,366 3,036,649 - 30,914,434 478,909 62,685,651 7,114,518 21,646,991 8,604,990 3,930,145 max 120 735,000 35 2 4,200 198,485 2,268,014 84 46 242 42,504 780 6 445 - 71 132 407 192 13 563 100 Graph Amazon BerkStan Epinions Gnutella Google LiveJournal NotreDame Pokec Slashdot0811 Slashdot0902 Stanford WikiTalk wikivote Youtube Orkut BuzzNet Delicious Digg Flixster Foursquare Friendster Lastfm S = 10 S = 100 number 1 16 2 1 40 30 88 1 1 2 6 1 8.82E15 1 4 80 19 1 1 6.64E6 1 1 number time 0.12 1 0.12 1.12E23 840 0.01 0.01 1 0.19 1.43E25 1.39 1.19E37 63,360 0.04 302,400 0.5 0.01 192 0.01 4,608 0.04 1.23E15 0.49 1 0 2.94E15 0.27 1 1.01 2.91E10 0.02 7.36E88 787,968 0.09 1 0.15 0.13 1 0.13 4.44E71 1 1.64 0.29 1 time 0.1 0.12 0.01 0.01 0.18 1.53 0.04 0.52 0.01 0.01 0.04 0.48 0 0.28 1.01 0.02 0.09 0.16 0.14 0.13 1.62 0.28 Table 6: SSM on seed set S by IM benchmark graphs by DviCL+X. Different from those constructed for real graphs, AutoTrees of most benchmark graphs contain only the root node. Revisit Table 2, most benchmark graphs are highly regular and contain none singleton cells, which makes DviCL and AutoTree useless in improving the performance. The efficiency on real datasets: Table 5 shows the efficiency of DviCL+X and X on real graphs. The 2nd, 4th, 6th, 8th, 10th and 12th columns show the running time of nauty, DviCL+n, traces, DviCL+t, bliss and DviCL+b, respectively. In Table 5, the sym- bol of "-" indicates that the algorithm cannot get the result in 2 hours, and the champion on each dataset is in bold. Several points can be made. First, among 22 datasets, DviCL+X outperform X in 14 datasets significantly. Specifically, in 3 datasets (Google, Live- Journal and WikiTalk), none of previous approaches can achieve the results, and in 10 datasets, none of previous approaches can obtain the results in 100 seconds. For the remaining 8 datasets, traces performances the best, however, its advantage over DviCL+t is marginal. Second, if we take DviCL as a preprocessing pro- Table 7: Subgraph clustering by SSM cedure, DviCL improves the efficiency and robustness of nauty, bliss and traces significantly. Third, among the 6 algorithms, only DviCL+X algorithms can achieve results in all datasets, and fur- thermore, DviCL+X can get the results in all datasets in less than 26 seconds. We explain the efficiency and robustness of DviCL. By constructing an AutoTree, DviCL is able to discover canonical labeling for only few small subgraphs instead of directly finding the canonical labeling for a massive graph for two reasons. (1) The AutoTree construction, including graph partition and canoni- cal labeling generation, is of low cost. (2) Finding canonical label- ing for small subgraphs is always efficient. Forth, for the graphs whose AutoTrees contain no non-singleton leaf nodes, all the three DviCL+X algorithms perform similarly. The 3rd, 5th, 7th, 9th, 11th and 13th columns illustrate the max memory consumptions of nauty, DviCL+n, traces, DviCL+t, bliss and DviCL+b, respectively. First, it is interesting to find that Algo- rithms DviCL+n, DviCL+t and DviCL+b consume almost the same amount of memory in each dataset, confirming our analysis when demonstrating the structure of AutoTrees. Second, bliss consumes the least amount of memory in most datasets. Graph nauty DviCL+n traces DviCL+t bliss DviCL+b ag2-49 cfi-200 difp-21-0-wal-rcr fpga11-20-uns-rcr grid-w-3-20 had-256 mz-aug-50 pg2-49 s3-3-3-10 0.04 27.62 8.52 0.09 < 0.01 0.08 4.35 0.04 0.01 0.04 0.07 0.02 1.79 0.01 0.02 0.01 0.23 0.02 < 0.01 0.12 < 0.01 4.35 < 0.01 0.04 0.08 0.02 < 0.01 0.04 0.21 0.02 0.66 0.02 0.05 0.01 < 0.01 0.03 0.01 0.51 0.05 0.001 0.01 0.04 0.25 0.02 0.02 0.19 0.67 0.02 0.01 0.02 0.51 0.01 0.21 0.02 Table 8: Performance on benchmark graphs The efficiency on benchmark datasets: Table 8 shows the effi- ciency of DviCL and its comparisons on benchmark graphs. The 2nd, 3rd, 4th, 5th, 6th and 7th columns show the running time of nauty, DviCL+n, traces, DviCL+t, bliss and DviCL+b, respec- tively. Worth noting that due to the accuracy of the timers pro- vided in nauty, traces and bliss, we equate < 0.01 with any value in [0, 0.01). From Table 8, almost all algorithms perform well in all datasets. Among these 6 algorithms, traces and DviCL+t are the best two approaches. Although traces performs the best in more datasets then DviCL+t, DviCL+t is more robust than traces. Specifically, DviCL+t can achieve the result in at most 0.04s in any benchmark dataset tested, while traces spends 0.23s in dealing with fpga11-20-uns-rcr. In conclusion, since AutoTrees constructed for real graphs are of low depths and non-singleton leaf nodes in AutoTrees are few and small, our DviCL reduces substantial redundant computations and significantly improves the performance for massive real graphs by introducing small extra cost for constructing AutoTrees. Due to the small sizes and regularity of benchmark graphs, the improvements are not remarkable. Applications of SSM: We study the applications of SSM. First, given a seed set S by influence maximization, we estimate the number of sets that have the same max influence as S. Here, S is obtained by PMC[28], one of the best performing algorithms for IM, and seed number k, i.e., S, is set as 10 and 100, respectively. Table 6 demonstrates the results. The 2nd and 4th columns show the number of candidate seed sets when S = 10 and S = 100, respectively. The 3rd and 5th columns show the running time for estimation. Several observations can be made. First, for a large number of graphs tested, numerous candidate sets can be found. Second, it is efficient to estimate the number of candidate sets. The reasons are as follows, 1) the most time consuming part in Algo- rithm SSM-AT is invoking SM on non-singleton leaf nodes (Line 3 in Algorithm 6); 2)in AutoTrees, non-singleton leaf nodes are few and are of small sizes. Second, we study subgraph clustering by SSM. Given a set of subgraphs in a graph G, all these subgraphs can be clustered s.t., each cluster contains subgraphs that are mutually symmetric. We consider the set of all maximum cliques and all triangles, and esti- mate the number of clusters and the size of the maximum cluster. Table 7 illustrates the results. The 2nd, 3rd and 4th columns shows the total number, the number of clusters and the size of the maxi- mum cluster for maximum cliques, respectively. The 5th, 6th and 7th columns shows the statistics for triangles, respectively. It is in- teresting to find that, 1) both the maximum cliques and triangles are diverse; 2) given a single maximum clique or a triangle, it is possible to find several symmetric ones by SSM. 8. CONCLUSION In this paper, we study graph isomorphism and automorphism detection for massive graphs. Different from the state-of-the-art algorithms that adopt an individualization-refinement schema for canonical labeling, we propose a novel efficient canonical label- ing algorithm DviCL following the divide-and-conquer paradigm. With DviCL, a tree-shape index, called AutoTree, is constructed for the given colored graph (G, π). AutoTree AT (G, π) provides in- sights into the symmetric structure of (G, π) in addition to the auto- morphism group and canonical labeling. We show that AT (G, π) can be used (1) to find all possible seed sets for influence maxi- mization and (2) to find all subgraphs in a graph G that are sym- metric to a given subgraph that exist in G. We conducted com- prehensive experimental studies to demonstrate the efficiency and robustness of our approach DviCL. First, non-singleton leaf nodes in AutoTrees constructed are few and small, and the AutoTrees are of low depths. Thus, the extra cost for AutoTree construction is low and worthy. Second, DviCL+X outperforms X, where X is for nauty, tracesand bliss, in 14 out of 22 datasets significantly. For the remaining 8 datasets, only traces can beat DviCL+X, whereas the advantages are marginal. Third, among these 6 algorithms tested, all of DviCL+X can achieve the results in all datasets in less than 26 seconds, while X is inefficient in most datasets. ACKNOWLEDGEMENTS: This work was supported by the grants from RGC 14203618, RGC 14202919, RGC 12201518, RGC 12232716, RGC 12258116, RGC 14205617 and NSFC 61602395. 9. REFERENCES [1] A. Arora, S. Galhotra, and S. Ranu. Debunking the myths of influence maximization: An in-depth benchmarking study. In Proc. of SIGMOD'17, 2017. [2] L. Babai, W. M. Kantor, and E. M. Luks. Computational complexity and the classification of finite simple groups. In Proc. of FOCS'83, 1983. [3] L. Babai and L. Kucera. Canonical labelling of graphs in linear average time. In Proc. of FOCS'79, 1979. [4] L. Babai and E. M. Luks. Canonical labeling of graphs. In Proc. of STOC'83, 1983. [5] H. L. Bodlaender. Polynomial algorithms for graph isomorphism and chromatic index on partial k-trees. Journal of Algorithms, 11(4), 1990. [6] D. Bonchev. Chemical graph theory: introduction and fundamentals, volume 1. CRC Press, 1991. [7] W. Bosma, J. Cannon, and C. Playoust. The magma algebra system i: The user language. Journal of Symbolic Computation, 24(3-4), 1997. [8] W. Chen, Y. Wang, and S. Yang. Efficient influence maximization in social networks. In Proc. of SIGKDD'09, 2009. [9] P. T. Darga, M. H. Liffiton, K. A. Sakallah, and I. L. Markov. Exploiting structure in symmetry detection for cnf. In Proc. of the 41st annual Design Automation Conference, 2004. [10] J. Ferrante, K. J. Ottenstein, and J. D. Warren. The program dependence graph and its use in optimization. ACM Transactions on Programming Languages and Systems (TOPLAS), 9(3), 1987. [11] I. S. Filotti and J. N. Mayer. A polynomial-time algorithm for determining the isomorphism of graphs of fixed genus. In Proc. of STOC'80, 1980. [12] M. R. Garey and D. S. Johnson. Computers and Intractability: A Guide to the Theory of NP-Completeness. 1979. [13] O. Goldreich, S. Micali, and A. Wigderson. Proofs that yield nothing but their validity or all languages in np have zero-knowledge proof systems. JACM, 38(3), 1991. [14] G. Group et al. Gap system for computational discrete algebra, 2007. [15] T. Junttila and P. Kaski. Engineering an efficient canonical labeling tool for large and sparse graphs. In Proc. of the Ninth Workshop on Algorithm Engineering and Experiments (ALENEX), 2007. [16] T. Junttila and P. Kaski. Conflict propagation and component recursion for canonical labeling. In Theory and Practice of Algorithms in (Computer) Systems. Springer, 2011. [17] D. Kempe, J. Kleinberg, and ´E. Tardos. Maximizing the spread of influence through a social network. In Proc. of SIGKDD'03, 2003. [18] W. Kocay. On writing isomorphism programs. In Computational and Constructive Design Theory. Springer, 1996. [19] D. J. Kuck, R. H. Kuhn, D. A. Padua, B. Leasure, and M. Wolfe. Dependence graphs and compiler optimizations. In Proceedings of the 8th ACM SIGPLAN-SIGACT symposium on Principles of programming languages. ACM, 1981. [20] T. Lappas, K. Liu, and E. Terzi. Finding a team of experts in social networks. In Proc. of KDD'09, 2009. [21] C. Liu, C. Chen, J. Han, and P. S. Yu. Gplag: detection of software plagiarism by program dependence graph analysis. In Proc. of SIGMOD'06. ACM, 2006. [22] C. Lu, J. X. Yu, H. Wei, and Y. Zhang. Finding the maximum clique in massive graphs. PVLDB'17, 10(11), 2017. [23] E. M. Luks. Isomorphism of graphs of bounded valence can be tested in polynomial time. Journal of computer and system sciences, 25(1), 1982. [24] B. D. MacArthur, R. J. S´anchez-Garc´ıa, and J. W. Anderson. Symmetry in complex networks. Discrete Applied Mathematics, 156(18), 2008. [25] B. D. McKay. Computing automorphisms and canonical labellings of graphs. In Combinatorial mathematics. Springer, 1978. [26] B. D. McKay et al. Practical graph isomorphism. 1981. [27] G. Miller. Isomorphism testing for graphs of bounded genus. In Proc. of STOC'80, 1980. [28] N. Ohsaka, T. Akiba, Y. Yoshida, and K.-i. Kawarabayashi. Fast and accurate influence maximization on large networks with pruned monte-carlo simulations. In AAAI, 2014. [29] S. Papadopoulos, Y. Kompatsiaris, A. Vakali, and P. Spyridonos. Community detection in social media. Data Mining and Knowledge Discovery, 24, 2012. [30] A. Piperno. Search space contraction in canonical labeling of graphs. arXiv preprint arXiv:0804.4881, 2008. [31] M. Randic, G. M. Brissey, and C. L. Wilkins. Computer perception of topological symmetry via canonical numbering of atoms. Journal of Chemical Information and Computer Sciences, 21(1), 1981. [32] R. C. Read and D. G. Corneil. The graph isomorphism disease. Journal of Graph Theory, 1(4), 1977. [33] B. Weisfeiler. On construction and identification of graphs, volume 558. Springer, 2006. [34] W. Wu, Y. Xiao, W. Wang, Z. He, and Z. Wang. K-symmetry model for identity anonymization in social networks. In Proc. of EDBT'10, 2010. [35] Y. Xiao, B. D. MacArthur, H. Wang, M. Xiong, and W. Wang. Network quotients: Structural skeletons of complex systems. Physical Review E, 78(4), 2008. [36] Y. Xiao, M. Xiong, W. Wang, and H. Wang. Emergence of symmetry in complex networks. Physical Review E, 77(6), 2008. [37] Y.-H. Xiao, W.-T. Wu, H. Wang, M. Xiong, and W. Wang. Symmetry-based structure entropy of complex networks. Physica A: Statistical Mechanics and its Applications, 387(11), 2008. [38] E. Yeger-Lotem, S. Sattath, N. Kashtan, S. Itzkovitz, R. Milo, R. Y. Pinter, U. Alon, and H. Margalit. Network motifs in integrated cellular networks of transcription -- regulation and protein -- protein interaction. PNAS, 101, 2004. [39] X. Zheng, T. Liu, Z. Yang, and J. Wang. Large cliques in arabidopsis gene coexpression network and motif discovery. Journal of plant physiology, 168, 2011.
1910.07879
1
1910
2019-10-17T13:11:42
Minimum entropy stochastic block models neglect edge distribution heterogeneity
[ "cs.SI", "cs.DM", "math.CO" ]
The statistical inference of stochastic block models as emerged as a mathematicaly principled method for identifying communities inside networks. Its objective is to find the node partition and the block-to-block adjacency matrix of maximum likelihood i.e. the one which has most probably generated the observed network. In practice, in the so-called microcanonical ensemble, it is frequently assumed that when comparing two models which have the same number and sizes of communities, the best one is the one of minimum entropy i.e. the one which can generate the less different networks. In this paper, we show that there are situations in which the minimum entropy model does not identify the most significant communities in terms of edge distribution, even though it generates the observed graph with a higher probability.
cs.SI
cs
Minimum entropy stochastic block models neglect edge distribution heterogeneity. Louis Duvivier1, C´eline Robardet1, and R´emy Cazabet2 1 Univ Lyon, INSA Lyon, CNRS, LIRIS UMR5205, F-69621 France [email protected], [email protected], 2 Univ Lyon, Universit´e Lyon 1, CNRS, LIRIS UMR5205, F-69622 France [email protected] Abstract. The statistical inference of stochastic block models as emerged as a mathematicaly principled method for identifying communities inside networks. Its objective is to find the node partition and the block-to-block adjacency matrix of maximum likelihood i.e. the one which has most probably generated the observed network. In practice, in the so-called microcanonical ensemble, it is frequently assumed that when comparing two models which have the same number and sizes of communities, the best one is the one of minimum entropy i.e. the one which can gener- ate the less different networks. In this paper, we show that there are situations in which the minimum entropy model does not identify the most significant communities in terms of edge distribution, even though it generates the observed graph with a higher probability. Keywords: network, community detection, stochastic block model, sta- tistical inference, entropy Since the seminal paper by Girvan and Newman [1], a lot of work has been devoted to finding community structure in networks [2]. The objective is to exploit the heterogeneity of connections in graphs to partition its nodes into groups and obtain a coarser description, which may be simpler to analyze. Yet, the absence of a universally accepted formal definition of what a community is has favored the development of diverse methods to partition the nodes of a graph, such as the famous modularity function [3], and the statistical inference of a stochastic block model [4]. This second method relies on the hypothesis that there exists an original partition of the nodes, and that the graph under study was generated by picking edges at random with a probability that depends only on the communities to which its extremities belong. The idea is then to infer the original node partition based on the observed edge distribution in the graph. This method has two main advantages with respect to modularity maximization: first, it is able to detect non-assortative connectivity pattern, i.e. groups of nodes that are not necessarily characterized by an internal density higher than the external density, and second it can be performed in a statistically significant way, while it has been shown that modularity may detect communities even in random graphs [5]. In 2 Louis Duvivier et al. particular, a bayesian stochastic blockmodeling approach has been developed in [6], which finds the most likely original partition for a SBM with respect to a graph by maximizing simultaneously the probability to choose this partition and the probability to generate this graph, given the partition. To perform the second maximization, this method assumes that all graphs are generated with the same probability and it thus searches a partition of min- imal entropy, in the sense that the cardinal of its microcanonical ensemble (i.e. the number of graphs the corresponding SBM can theoretically generate [7]) is minimal, which is equivalent to maximizing its likelihood[8]. In this paper, we show that even when the number and the size of the communities are fixed, the node partition which corresponds to the sharper communities is not always the one with the lower entropy. We then demonstrate that when community sizes and edge distribution are heterogeneous enough, a node partition which places small communities where there are the most edges will always have a lower entropy. Finally, we illustrate how this issue implies that such heterogeneous stochas- tic block models cannot be identified correctly by this model selection method and discuss the relevance of assuming an equal probability for all graphs in this context. 1 Entropy based stochastic block model selection The stochastic block model is a generative model for random graphs. It takes as parameters a set of nodes V = [1; n] partitioned in p blocks (or communities) C = (ci)i∈[1;p] and a block-to-block adjacency matrix M whose entries correspond to the number of edges between two blocks. The corresponding set of generable graphs G = (V, E) with weight matrix W is defined as: G ∀c1, c2 ∈ C, (cid:88) i∈ci,j∈cj ΩC,M = W(i,j) = M(c1,c2)  It is called the microcanonical ensemble (a vocabulary borrowed to statistical physics [7]) and it can be refined to impose that all graphs are simple, undirected (in which case M must be symmetric) and to allow or not self loops. In this paper we will consider multigraphs with self loops, because they allow for simpler computations. Generating a graph with the stochastic block model associated to C, M amounts to drawing at random G ∈ ΩC,M . The probability distribution P[GC, M ] on this ensemble is defined as the one which maximizes Shanon's entropy P[GC, M ] × ln(P[GC, M ]) (cid:88) S = G∈ΩC,M In the absence of other restriction, the maximum entropy distribution is the flat one: P[GC, M ] = 1 ΩC,M Minimum entropy stochastic block models 3 whose entropy equals S = ln(ΩC,M). It has been computed for different SBM flavours in [8]. It measures the number of different graphs a SBM can generate with a given set of parameters. The lower it is, the higher the probability to generate any specific graph G. On the other hand, given a graph G = (V, E), with a weight matrix W , it may have been generated by many different stochastic block models. For any partition C = (ci)i∈[1;p] of V , there exists one and only one matrix M such that G ∈ ΩC,M , and it is defined as: ∀c1, c2 ∈ C, M(c1,c2) = (cid:88) W(i,j) i∈c1,j∈c2 Therefore, when there is no ambiguity about the graph G, we will consider indifferently a partition and the associated SBM in the following. The objective of stochastic block model inference is to find the partition C that best describes G. To do so, bayesian inference relies on the Bayes theorem which stands that: P[C, MG] = P[GC, M ] × P[C, M ] P[G] (1) As P[G] is the same whatever C, it is sufficient to maximize P[GC, M ] × P[C, M ]. The naive approach which consists in using a maximum-entropy uni- form prior distribution for P[C, M ] simplifies the computation to maximizing directly P[GC] (the so called likelihood function) but it will always lead to the trivial partition ∀i ∈ V, ci = {i}, which is of no use because the corresponding SBM reproduces G exactly: M = W and P[GC] = 1. To overcome this overfit- ting problem, another prior distribution was proposed in [9], which assigns lower probabilities to the partitions with many communities. Yet, when comparing two models C1, M1 and C2, M2 with equal probability, the one which is chosen is still the one minimizing ΩC,M or equivalently the entropy S = ln(ΩC,M), as logarithm is a monotonous function. 2 The issue with heavily populated graph regions In this paper, we focus on the consequence of minimizing the entropy to dis- criminate between node partitions. To do so, we need to work on a domain of partitions on which the prior distribution is uniform. As suggested by [9], we restrict ourselves to finding the best partition when the number p and the sizes (si)i∈[1;p] of communities are fixed because in this case, both P [C] and P [MC] are constant. This is a problem of node classification, and in this situation the maximization of equation 1 boils down to minimizing the entropy of ΩC,M , which can be written as: (cid:88) (cid:20)(cid:18)sisj + M(i,j) − 1 (cid:19)(cid:21) S = ln i,j∈[1;p] M(i,j) 4 Louis Duvivier et al. as shown in [8]. Yet, even within this restricted domain (p and (si)i are fixed), the lower en- tropy partition for a given graph G is not always the one which corresponds to the sharper communities. To illustrate this phenomena, let's consider the stochas- tic block models whose matrices M are shown on figure 1, and a multigraph G ∈ ΩSBM1 ∩ ΩSBM2. 1 : {9, 10, 11}} -- SBM1 corresponds to C1 = {ca -- SBM2 corresponds to C2 = {ca 2 : {6, 7, 8, 9, 10, 11}}. As G ∈ ΩSBM1 ∩ ΩSBM2, it could have been generated using SBM1 or SBM2. Yet, the point of inferring a stochastic block model to understand the structure of a graph is that it is supposed to identify groups of nodes (blocks) such that the edge distribution between any two of them is homogeneous and characterized by a specific density. From this point of view C1 seems a better partition than C2: 1 : {0, 1, 2, 3, 4, 5}, cb 2 : {0, 1, 2}, cb 1 : {6, 7, 8}, cc 2 : {3, 4, 5}, cc -- The density of edges inside and between ca 2 and cb 2 is the same (10), so there is no justification for dividing ca 1 in two. -- On the other hand, cb 1 have an internal density of 1 and there is no edge between them, so it is logical to separate them rather than merge them into cc 2. 1 and cc Yet, if we compute the entropy of SBM1 and SBM2: (cid:20)(cid:18)395 (cid:19)(cid:21) (cid:19)(cid:21) (cid:20)(cid:18)53 360 18 + 2 × ln + 4 × ln (cid:20)(cid:18)17 (cid:19)(cid:21) (cid:20)(cid:18)98 (cid:19)(cid:21) 9 90 = 136 = 135 S1 = ln S2 = ln The entropy of SBM2 is lower and thus partition C2 will be the one selected. Of course, as ΩSBM2 < ΩSBM1, the probability to generate G with SBM2 is higher than the probability to generate it with SBM1. But this increased proba- bility is not due to a better identification of the edge distribution heterogeneity, it is a mechanical effect of imposing smaller communities in the groups of nodes which contain the more edges, even if their distribution is homogeneous. Doing so reduces the number of possible positions for each edge and thus the number of different graphs the model can generate. This problem can also occur with smaller densities, as illustrated by the stochastic block models whose block-to-block adjacency matrices are shown on figure 2. SBM3, defined as one community of 128 nodes and density 0.6 and 32 communities of 4 nodes and density 0.4 has an entropy of 17851. SBM4 which merges all small communities into one big and splits the big one into 32 small ones has an entropy of 16403. Minimum entropy stochastic block models 5 Fig. 1. Block-to-block adjacency matrices of two overlapping stochastic block models. Even though the communities of SBM1 are better defined, SBM2 can generate less different graphs and thus generates them with higher probability. Fig. 2. Block-to-block adjacency matrices of two overlapping stochastic block models with lower densities. Once again, even though SBM3 has better defined communities, SBM4 is more likely a model for graphs G ∈ ΩSBM3 ∩ ΩSBM4 6 Louis Duvivier et al. 3 The density threshold More generally, let's consider a SBM (C1, M1) with one big community of size s, containing c× m0 edges and q small communities of size s q containing (mi)i∈[1;q] edges each, as illustrated on figure 3. Its entropy is equal to: (cid:20)(cid:18)s2 + c × m0 − 1 (cid:19)(cid:21) c × m0 q(cid:88) i=1 ln + S1(c) = ln (cid:34)(cid:18) s2 (cid:19)(cid:35) q2 + mi − 1 mi On the other hand, the entropy of the SBM (C2, M2) which splits the big com- munity into q small ones of size s q and merges the q small communities into one big is: (cid:20)(cid:18)s2 +(cid:80)q (cid:80)q i=1 mi − 1 i=1 mi (cid:19)(cid:21) + q2ln S2(c) = ln (cid:19)(cid:35) − 1 (cid:34)(cid:18) s2+c×m0 q2 c×m0 q2 Fig. 3. Theoretical pair of stochastic block models. The right-side partition splits the big community in q = 3 small ones and merges the small communities in one big. So, with C1 = (cid:80)q are constants with respect to c: S1(c) − S2(c) = ln = ln = ln > ln > q2 Now, as and we have that q2 Minimum entropy stochastic block models 7 , which q2 − 1 q2 c×m0 (cid:1)(cid:105) − q2ln and C2 = ln + C1 − C2 (cid:104)(cid:0)s2+(cid:80)q (cid:80)q i=1 mi−1 i=1 mi (cid:34)(cid:18) s2+c×m0   c×m0 q2(cid:89) (cid:33)q2 + C1 − C2 (cid:19)(cid:35) q2 + C1 − C2  + C1 − C2 k + s2 k q2 − 1 q2 ) − ln k=1 (k + s2 q2 − 1)q2 (cid:81)q2−1 i=0 (k + s2 − 1 + i × c×m0 (cid:32) (cid:20) k + s2 − 1 q2 − 1 k + s2 (cid:21) (q2 − 1)s2 q2k + s2 − q2 + C1 − C2 k mi k=1 i=1 ln q2 +mi−1 c × m0 k + s2 − 1 (cid:20)(cid:0) s2 (cid:1)(cid:21) (cid:20)(cid:18)s2 + c × m0 − 1 (cid:19)(cid:21) (cid:35) (cid:34)c×m0(cid:89)  c×m0 q2(cid:89)  c×m0 q2(cid:89) q2(cid:88) (cid:20) (q2 − 1)s2 q2k + s2 − q2 c×m0 1 + k=1 k=1 k=1 ln (cid:21) ln 1 + ∼ k→∞ (q2 − 1)s2 q2k + s2 − q2 c×m0 q2(cid:88) q2(cid:88) k=1 c×m0 ln k=1 (q2 − 1)s2 q2k + s2 − q2 → (cid:20) c→∞ ∞ (cid:21) (q2 − 1)s2 q2k + s2 − q2 1 + → c→∞ ∞ (2) (3) and thus, by injecting equation 3 inside 2, ∃c,∀c(cid:48) > c, S2(c(cid:48)) < S1(c(cid:48)). Which means that for any such pair of stochastic block models, there exists some density threshold for the big community in C1 above which (C2, M2) will be identified as the most likely model for all graphs G ∈ Ω(C1,M1) ∩ Ω(C2,M2). 4 Consequences on model selection In practice, this phenomena implies that a model selection technique based on the minimization of entropy will not be able to identify correctly some SBM when they are used as generative models for synthetic graphs. To illustrate this, 8 Louis Duvivier et al. we generate graphs and try to recover the original partition. The experiment is conducted on two series of stochastic block models, one with relatively large communities and another one with smaller but more sharply defined communi- ties: -- SBM7(d) is made of 5 blocks (1 of 40 nodes, and 4 of 10 nodes). Its density matrix D is given on figure 4 (left) (one can deduce the block adjacency matrix by M(ci,cj ) = cicj × D(ci,cj )). -- SBM8(d) is made of 11 blocks (1 of 100 nodes, and 10 of 10 nodes). The internal density of the big community is d, it is 0.15 for the small ones and 0.01 between communities. For each of those two models, and for various internal densities d of the largest community, we generate 1000 random graphs. For each of these graphs, we com- pute the entropy of the original partition (correct partition) and the entropy of the partition obtained by inverting the big community with the small ones (incorrect partition). Then, we compute the percentage of graphs for which the correct partition has a lower entropy than the incorrect one and plot it against the density d. Results are shown on figure 4 and 5. Fig. 4. Block-to-block adjacency matrix of SBM7(d) (left) and percentage of graphs generated using SBM7(d) for which the original partition has a lower entropy than the inverted one against the density d of the big community (right). We observe that as soon as d reaches a given density threshold (about 0.08 for SBM7(d) and 0.18 for SBM8(d)), the percentage of correct match drops quickly to 0. As d rises over 0.25, the correct partition is never the one selected. It should be highlighted that in these experiments we only compared two partitions among the Bn possible, so the percentage of correct match is actually an upper bound on the percentage of graphs for which the correct partition is identified. This means that if SBM7(d) or SBM8(d) are used as generative models for random graphs, with d > 0.25, and one wants to use bayesian inference for determining the Minimum entropy stochastic block models 9 Fig. 5. Percentage of graphs generated using SBM8(d) for which the original partition has a lower entropy than the inverted one against the density d of the big community. original partition, it will almost never return the correct one. What is more, the results of section 3 show that this will occur for any SBM of the form described in figure 3, as soon as the big community contains enough edges. 5 Discussion We have seen in section 1 that model selection techniques that rely on the max- imization of the likelihood function to find the best node partition given an ob- served graph boils down to the minimization of the entropy of the corresponding ensemble of generable graphs in the microcanonical framework. Even in the case of bayesian inference, when a non-uniform prior distribution is defined on the set of possible partitions, entropy remains the criterion of choice between equiprob- able partitions. Yet, as shown in section 2 and 3, entropy behaves counter intu- itively when a large part of the edges are concentrated inside one big community. In this situation, a partition that splits this community in small ones will have a lower entropy, even though the edge density is homogeneous. Furthermore, this happens even when the number and sizes of communities are known. Practically, as explained in section 4, this phenomena implies that stochastic block models of this form cannot be recovered using model selection techniques based on the mere minimization of the cardinal of the associated microcanonical ensemble. 10 Louis Duvivier et al. Let's stress that contrary to the resolution limit described in [10] or [11], the problem is not about being able or not to detect small communities with no prior knowledge about the graph, it occurs even though the number and sizes of communities are known. It is also different from the phase transition issue that has been investigated in [12] [13] [14] [15] for communities detection or recovery because it happens even when communities are dense and perfectly separated. Entropy minimization fails at classifying correctly the nodes between communities because it only aims at identifying the SBM that can generate the lowest number of different graphs. A model which enforces more constraints on edge positions will necessarily perform better from this point of view, but this is a form of overfitting, in the sense that the additional constraints on edge placement are not justified by an heterogeneity in the observed edge distribution. The results presented in this paper were obtained for a particular class of stochastic block models. First of all, they were obtained for the multigraph flavour of stochastic block models. As the node classification issue occurs also for densities below 1, they can probably be extended to simple graphs, but this would need to be checked, as well as the case of degree-corrected stochastic block models. Furthermore, the reason why the log-likelihood of a stochastic block model C, M for a graph G is equal to the entropy of ΩC,M is that we consider the microcanonical ensemble, in which all graphs have an equal probability to be generated. It would be interesting to check if similar results can be obtained when computing P[GC, M ] in the canonical ensemble [8]. Finally, we assumed that for a graph G and two partitions C1 and C2 with the same number and sizes of blocks, the associated block-to-block adjacency matrices M1 and M2 have the same probability to be generated, and this assumption too could be questioned. Yet, within this specific class of SBM, our results illustrate a fundamental issue with the stochastic block model statistical inference process. Since the ran- dom variable whose distribution we are trying to infer is the whole graph itself, we are performing statistical inference on a single observation. This is why fre- quentist inference is impossible, but bayesian inference also has strong limitations in this context. In particular, the only tool to counterbalance the observation and avoid overfitting is to specify the kind of communities we are looking for through the prior distribution. If it is agnostic about the distribution of edge densities among these communities, the mere minimization of the entropy of the posterior distribution fails to identify the heterogeneity in the edge distribution. Beside refining even more the prior distribution, another approach could be to consider a graph as the aggregated result of a series of edge positioning. If the considered random variable is the position of an edge, a single graph observation contains information about many of its realizations, which reduces the risk of overfitting. Acknowledgments This work was supported by the ACADEMICS grant of the IDEXLYON, project of the Universit de Lyon, PIA operated by ANR-16-IDEX-0005, and of the Minimum entropy stochastic block models 11 project ANR-18-CE23-0004 (BITUNAM) of the French National Research Agency (ANR). References 1. Michelle Girvan and Mark EJ Newman. Community structure in social and biolog- ical networks. Proceedings of the national academy of sciences, 99(12):7821 -- 7826, 2002. 2. Santo Fortunato and Darko Hric. Community detection in networks: A user guide. Physics reports, 659:1 -- 44, 2016. 3. Mark EJ Newman and Michelle Girvan. Finding and evaluating community struc- ture in networks. Physical review E, 69(2):026113, 2004. 4. Matthew B Hastings. Community detection as an inference problem. Physical Review E, 74(3):035102, 2006. 5. Roger Guimera, Marta Sales-Pardo, and Lu´ıs A Nunes Amaral. Modularity from fluctuations in random graphs and complex networks. Physical Review E, 70(2):025101, 2004. 6. Tiago P Peixoto. Nonparametric bayesian inference of the microcanonical stochas- tic block model. Physical Review E, 95(1):012317, 2017. 7. Giulio Cimini, Tiziano Squartini, Fabio Saracco, Diego Garlaschelli, Andrea Gabrielli, and Guido Caldarelli. The statistical physics of real-world networks. Nature Reviews Physics, 1(1):58, 2019. 8. Tiago P Peixoto. Entropy of stochastic blockmodel ensembles. Physical Review E, 85(5):056122, 2012. 9. Tiago P Peixoto. Bayesian stochastic blockmodeling. arXiv preprint arXiv:1705.10225, 2017. 10. Santo Fortunato and Marc Barthelemy. Resolution limit in community detection. Proceedings of the national academy of sciences, 104(1):36 -- 41, 2007. 11. Tiago P Peixoto. Parsimonious module inference in large networks. Physical review letters, 110(14):148701, 2013. 12. Aurelien Decelle, Florent Krzakala, Cristopher Moore, and Lenka Zdeborov´a. Infer- ence and phase transitions in the detection of modules in sparse networks. Physical Review Letters, 107(6):065701, 2011. 13. Aurelien Decelle, Florent Krzakala, Cristopher Moore, and Lenka Zdeborov´a. Asymptotic analysis of the stochastic block model for modular networks and its algorithmic applications. Physical Review E, 84(6):066106, 2011. 14. Dandan Hu, Peter Ronhovde, and Zohar Nussinov. Phase transitions in random potts systems and the community detection problem: spin-glass type and dynamic perspectives. Philosophical Magazine, 92(4):406 -- 445, 2012. 15. Emmanuel Abbe and Colin Sandon. Community detection in general stochastic block models: Fundamental limits and efficient algorithms for recovery. In 2015 IEEE 56th Annual Symposium on Foundations of Computer Science, pages 670 -- 688. IEEE, 2015.
1501.00594
2
1501
2015-06-16T10:14:11
Stochastic block model and exploratory analysis in signed networks
[ "cs.SI", "physics.soc-ph" ]
We propose a generalized stochastic block model to explore the mesoscopic structures in signed networks by grouping vertices that exhibit similar positive and negative connection profiles into the same cluster. In this model, the group memberships are viewed as hidden or unobserved quantities, and the connection patterns between groups are explicitly characterized by two block matrices, one for positive links and the other for negative links. By fitting the model to the observed network, we can not only extract various structural patterns existing in the network without prior knowledge, but also recognize what specific structures we obtained. Furthermore, the model parameters provide vital clues about the probabilities that each vertex belongs to different groups and the centrality of each vertex in its corresponding group. This information sheds light on the discovery of the networks' overlapping structures and the identification of two types of important vertices, which serve as the cores of each group and the bridges between different groups, respectively. Experiments on a series of synthetic and real-life networks show the effectiveness as well as the superiority of our model.
cs.SI
cs
Stochastic block model and exploratory analysis in signed networks Department of Computer Science, City University of Hong Kong, 83 Tat Chee Avenue, Kowloon, Hong Kong Jonathan Q. Jiang∗ We propose a generalized stochastic block model to explore the mesoscopic structures in signed networks by grouping vertices that exhibit similar positive and negative connection profiles into the same cluster. In this model, the group memberships are viewed as hidden or unobserved quantities, and the connection patterns between groups are explicitly characterized by two block matrices, one for positive links and the other for negative links. By fitting the model to the observed network, we can not only extract various structural patterns existing in the network without prior knowledge, but also recognize what specific structures we obtained. Furthermore, the model parameters provide vital clues about the probabilities that each vertex belongs to different groups and the centrality of each vertex in its corresponding group. This information sheds light on the discovery of the networks overlapping structures and the identification of two types of important vertices, which serve as the cores of each group and the bridges between different groups, respectively. Experiments on a series of synthetic and real-life networks show the effectiveness as well as the superiority of our model. PACS numbers: 89.75.Fb, 05.10.-a I. INTRODUCTION The study of networks has received considerable atten- tion in recent literature [1–3]. This is mainly attributed to the fact that a network provides a concise mathemat- ical representation for social [4, 5], technological [6], bio- logical [7–9] and other complex systems [1–3] in the real world, which paves the way for executing proper analysis of such systems’ organizations, functions and dynamics. Many networks are found to possess a multitude of mesoscopic structural patterns, which can be coarsely divided into “assortative” or “community” structure and “disassortative” or “bipartitie/multipartite” struc- ture [10, 11]. In addition, other types of mesoscopic structures, such as the “core-periphery” motif, have been observed in real-life networks as well. Along with these discoveries, a large number of techniques have been pro- posed for mesoscopic structure extraction, in particular for community detection (see, e.g. [8, 10–14] and recent reviews [2, 3, 15]). Most, if not all, existing techniques require us to know which specific structure we are looking for before we study it. Unfortunately, we often know lit- tle about a given network and have no idea what specific structures can be expected and subsequently detected by what specific methods. Biased results will be obtained if an inappropriate method is chosen. Even if we know something beforehand, it is still difficult for a method that is exclusively designed for a certain type of meso- scopic structure to uncover the aforementioned miscel- laneous structures that may simultaneously coexist in a network or may even overlap with each other [8, 16–20]. To overcome these difficulties, a mixture model [11], a stochastic block model [21] and their various extensions and combinations [22–27] have been recently introduced ∗Current address: Department of Mathematics, Hong Kong Bap- tist University, Kowloon Tong, Hong Kong to enable an “exploratory” analysis of networks, allowing us to extract unspecified structural patterns even if some edges in the networks are missing [28, 29]. By fitting the model to the observed network structure, vertices with the same connection profiles are categorized into a pre- defined number of groups. The philosophy of these ap- proaches is quite similar to that of the “role model” in so- ciology [30]—individuals having locally or globally anal- ogous relationships with others play the same “role” or take up the same “position” [31]. It is clear to see that the possible topologies of the groups include community structure and multipartite structure, but they can be much, much wider. One common assumption shared by these models is that the target networks contain positive links only. How- ever, we frequently encounter the signed networks, which have both positive and negative edges, in biology [19, 32], computer science [33], and last but definitely not least, social science [34–37]. The negative connections usually represent hostility, conflict, opposition, disagreement, and distrust between individuals or organizations, as well as the anticorrelation among objectives, whose coupled relation with positive links has been empirically shown to play a crucial role in the function and evolution of the whole network [32, 37]. Several works have been conducted to detect commu- nity structure in these kinds of networks. Yang et al. [34] proposed an agent-based method that performs a ran- dom walk from one specific vertex for a few steps to mine the communities in positive and signed networks. G´omez et al. [35] presented a generalization of the widely-used modularity [10, 14] to allow for negative links. Traag and Bruggeman [36] extended the Potts model to incor- porate negative edges, resulting in a method similar to the clustering of signed graphs. These approaches focus on the problem of community detection and thus they inevitably suffer a devastating failure if the signed net- works comprise other structural patterns, for example the disassortative structure, as shown in Sec. IV A. To make matters worse, they simply give a “hard” partition of signed networks in which a specific vertex could be- long to one and only one cluster. Similar to the positive networks, we have good reason to believe that the signed networks also simultaneously include all kinds of meso- scopic structures that might overlap with each other. In this paper, we aim to capture and extract the intrin- sic mesoscopic structure of networks with both positive and negative links. This goal is achieved by dividing the vertices into groups such that the vertices within each group have similar positive and negative connection pat- terns to other groups. We propose a generalized stochas- tic block model, referred to as signed stochastic block model (SSBM), in which the group memberships of each vertex are represented by unobserved or hidden quan- tities, and the relationship among groups is explicitly characterized by two block matrices, one for the positive links and the other for the negative links. By using the expectation-maximization algorithm, we fit the model to the observed network structure and reveal the structural patterns without prior knowledge of what specific struc- tures existing in the network. As a result, not only can various unspecific structures be successfully found, but also their types can be immediately elucidated by the block matrices. In addition, the model parameters tell us the fuzzy group memberships and the centrality of each vertex, which enable us to discover the networks’ over- lapping structures and to identify two kind of important vertices, i.e., group core and bridge. Experiments on a number of synthetic and real world networks validate the effectiveness and the advantage of our model. The rest of this paper is organized as follows. We be- gin with the depictions of the mesoscopic structures, es- pecially the definitions of the community structure and disassortative structure, in signed networks in Sec. II. Then we introduce an extension of the stochastic block model in Sec. III, and show how to employ it to perform an exploratory analysis of a given network with both pos- itive and negative links. Experimental results on a series of synthetic networks with various designed structures and three social networks are given in Sec. IV, followed by the conclusions in Sec. V. II. MESOSCOPIC STRUCTURES IN SIGNED NETWORKS It is well known that the mesoscopic structural pat- terns in positive networks can be roughly classified into the following two different types: “Assortative struc- ture”, usually called “community structure” in most cases, refers to groups of vertices within which connec- tions are relatively dense and between which they are sparser [10–12]. In contrast, “disassortative structure”, also named “bipartite structure” or more generally “mul- tipartite structure”, means that network vertices have most of their connections outside their group [10, 11, 13]. For a signed network, its mesoscopic structure is quite 2 different from and much more complicated than that in a positive network since both the density and the sign of the links should be taken into account at the same time. The intuitive descriptions of the assortative struc- ture and disassortative structure given in Ref. [10, 11] are no longer suitable. A natural question arises: How can we characterize the mesoscopic structures in a network that has both positive and negative edges? Guidance can be provided by the social balance theory [38], which states that the attitudes of two individuals toward a third per- son should match if they are positively related. In this situation, the triad is said to be socially balanced. A network is called balanced provided that all its triads are balanced. This concept can be further generalized to k- balance [39, 40] when the network can be divided into k clusters, each having only positive links within itself and negative links with others. Following the principle, we can reasonably describe the community structure in a signed network as a set of groups of vertices within which positive links are com- paratively dense and negative links are sparser, and on the contrary between which positive links are much looser and negative links are thicker [34–36]. Obviously, it is an extension of the standard community structure in net- works with positive edges. In contrast, the disassortative structure can be defined as a collection of vertices that have most of their negative links within the group to which they belong while have majority of their positive connections outside their group. III. METHODS A. The SSBM Model Given a directed network G = (V, E), we can represent it by an adjacency matrix A. The entries of the matrix are defined as: Aij = 1 if a positive link is present from vertex i to vertex j, Aij = −1 if a negative link is present from vertex i to vertex j, and Aij = 0 otherwise. For weighted networks, Aij can be generalized to represent the weight of the link. We further separate the positive component from the negative one by setting A+ ij = Aij if ij = −Aij if Aij < 0 and Aij > 0 and 0 otherwise, and A− 0 otherwise, so A = A+ − A−. Suppose that the vertices fall into c groups whose mem- berships are “hidden” or “missing” for the moment and will be inferred from the observed network structure. The number of groups c can also be inferred from the data, which will be discussed in Sec. III C, but we take it as a given here. The standard solution for such an inference problem is to give a generative model for the observed network structure and then to determine the parameters of the model by finding its best fit [11, 22–25]. The model we use is a kind of stochastic block model that parameterizes the probability of each possible con- figuration of group assignments and edges as follows (see Fig. 1 for a schematic illustration). Given an edge eij, 3 observe a positive edge e+ ij can be written as Pr(e+ ijω+, θ, φ) = ω+ rsθriφsj, (1) and the probability of observing a negative edge e− ij is Pr(e− ijω−, θ, φ) = ω− rsθriφsj. (2) (cid:88) rs (cid:88) rs The marginal likelihood of the signed network, therefore, can be represented by Pr(Aω+, ω−, θ, φ) (cid:89) (cid:18)(cid:88) (cid:19)A+ ij(cid:18)(cid:88) = ω+ rsθriφsj ij rs rs ω− rsθriφsj . (3) (cid:19)A − ij Note that the self-loop links are allowed and the weight ij and A− A+ ij are respectively viewed as the number of pos- itive and negative multiple links from vertex i to vertex To infer the missing group memberships ←−g and −→g , we j as done in many existing models [23–25]. need to maximize the likelihood in Eq. (3) with respect to the model parameters ω+, ω−, θ and φ. For convenience, one usually works not directly with the likelihood itself but with its logarithm L = lnPr(Aω+, ω−, θ, φ) (cid:88) (cid:88) ij + (cid:32)(cid:88) (cid:32)(cid:88) rs = A+ ijln ω+ r,sθriφsj A− ijln ω− r,sθriφsj (cid:33) (cid:33) . (4) FIG. 1: Stochastic block model for signed networks. Unfilled circles represent observed network structure and filled ones correspond to hidden memberships. The solid line between vertex i and j indicates the existence of one positive or nega- tive edge connecting them. The dashed line indicates that the relation between the corresponding quantities is unobserved and requires being learned from the observed network data. rs and ω− we choose a pair of group r and s for its tail and head with probability ω+ rs if eij is positive, or with probability ω− rs if eij is negative. The two scalars ω+ rs giv- ing the probability that a randomly selected positive and negative edge from group r to s respectively, explicitly characterize various types of connecting patterns among groups, as we will see later. Then, we draw the tail ver- tex i from group r with probability θri and the head vertex j from group s with probability φsj. Intuitively, the parameter θri captures the centrality of vertex i in the group r from the perspective of outgoing edges while φsj describes the centrality of vertex j in the group s from the perspective of incoming edges. The parameters rs, ω− ω+ rs, θri and φsj satisfy the normalization condition c(cid:88) c(cid:88) r=1 s=1 c(cid:88) c(cid:88) n(cid:88) s=1 ω+ rs = 1, n(cid:88) r=1 θri = 1, ω− rs = 1, φsj = 1. ij rs i=1 j=1 Let ←−g ij and −→g ij to be respectively the group member- ship of the tail and head of the edge eij. So far, we served quantities {Aij}, hidden quantities {−→g ij,←−g ij} have introduced all the quantities in our model: ob- rs, θri, φsj}. To simplify and model parameters {ω+ the notations, we shall henceforth denote by ω+ the en- rs} and similarly ω−, θ, φ, ←−g and −→g for {ω− tire set {ω+ rs}, {θri}, {φsj}, {←−g ij} and {−→g ij}. The probability that we rs, ω− The maximum of the likelihood and its logarithm occur in the same place because the logarithm is a monotonically increasing function. Considering that the group memberships ←−g and −→g are unknown, it is intractable to optimize the log-likelihood L directly again. We can, however, give a good guess of the hidden variables ←−g and −→g according to the net- work structure and the model parameters, and seek the maximization of the following expected log-likelihood ←−g ,−→g (cid:88) (cid:88) (cid:88) ijrs L = = = (cid:20) (cid:0)lnω+ Pr(r, se+ ij, ω+, θ, φ) A+ ij (cid:0)lnω+ rs + lnθri + lnφsj (cid:88) (cid:1) + q+ ijrsA+ ij rs + lnθri + lnφsj ijrs ijrs q− ijrsA− ij rs + lnθri + lnφsj (cid:1), Pr(←−g ,−→g A+, ω+, θ, φ)lnPr(A+←−g ,−→g , ω+, θ, φ) + Pr(←−g ,−→g A−, ω−, θ, φ)lnPr(A−←−g ,−→g , ω−, θ, φ) ←−g ,−→g (cid:88) (cid:1)(cid:21) (cid:88) (cid:0)lnω− ijrs + (cid:20) ij, ω−, θ, φ) A− ij (cid:0)lnω− Pr(r, se− rs + lnθri + lnφsj (cid:1)(cid:21) (5) rsijNode:1, , nGroup:1, , cA+ij(cid:550)+rs(cid:537)ri(cid:307)sjijA-ijrs(cid:550)-rs(cid:537)ri(cid:307)sj the expected log-likelihood appears at the places where 4  ω+ rs = ω− rs = θri = φsj = (cid:80) (cid:80) ij A+ ijq+ (cid:80) ijrs A+ ijq+ (cid:80) ij A− ijq− (cid:80) ijrs A− ijq− (cid:80) ijq+ js A+ (cid:80) ijq+ ijs A+ (cid:80) ir A+ ijq+ ijq+ ijr A+ ijrs , ijrs , ijrs ijrs ijrs +(cid:80) ijrs +(cid:80) ijrs +(cid:80) ijrs +(cid:80) ijrs ijq− js A− ijs A− ijq− ir A− ijq− ijq− ijr A− ijrs ijrs ijrs (8) , . By letting the derivative of L to be 0, the maximum of αir = , (9) ijrs = Pr(←−g ij = r,−→g ij = se+ where q+ ij, ω+, θ, φ) is the probability that one find a positive edge e+ ij with its tail vertex i from group r and its head vertex j from group s ijrs = Pr(←−g ij = r,−→g ij = given the network and the model parameters. Analogous interpretation can be made for q− se− ij, ω−, θ, φ) too. With the expected log-likelihood, we can get the best estimate of the value of L together with the position of its maximum gives the most likely values of the model pa- rameters. Finding the maximum still presents a problem, however, since the calculation of q+ ijrs requires the values of ω+, ω−, θ and φ, and vice versa. One possible solution is to adopt an iterative self-consistent approach that evaluates both simultaneously. Like many previous works [11, 23–25], we utilize the expectation- maximization (EM) algorithm, which first computes the posterior probabilities of hidden variables using esti- mated model parameters and observed data (the E-step), and then re-estimates the model parameters (the M- step). In the E-step, we calculate the expected probabilities ijrs and q− q+ ijrs given the observed network A and param- eters ω+, ω−, θ and φ ijrs and q−  q+ ijrs = = q− ijrs = = ijω+, θ, φ) ijω−, θ, φ) (6) , Pr(e+ Pr(←−g ij = r,−→g ij = s, e+ ijω+, θ, φ) (cid:80) ω+ rsθriφsj rs ω+ Pr(←−g ij = r,−→g ij = s, e− ijω−, θ, φ) (cid:80) ω− rsθriφsj rs ω− Pr(e− rsθriφsj rsθriφsj . ijrs and q− In the M-step, we use the values of q+ ijrs es- timated in the E-step, to evaluate the expected log- likelihood and to find the values of the parameters that Introducing the Lagrange multipliers ρ+, maximize it. ρ−, γr and λs to incorporate the normalization condi- tions, the expected log-likelihood expression to be maxi- mized becomes (cid:18) 1 −(cid:88) 1 −(cid:88) rs (cid:19) ω+ rs (cid:19) + ρ−(cid:18) 1 −(cid:88) (cid:18) 1 −(cid:88) (cid:88) rs λs θri + (cid:19) (cid:19) + ω− rs φsj . (7) L = L + ρ+ (cid:88) (cid:18) γr r i s j Eq. (6) and (8) constitute our EM algorithm for ex- ploratory analysis of signed networks. When the algo- rithm converges, we obtain a set of values for hidden ijrs and model parameters ω+, ω−, θ quantities q+ and φ. ijrs, q− It is worthwhile to note that the EM algorithm are known to converge to local maxima of the likelihood but not always to global maxima. With different starting values, the algorithm may give rise to different solutions. To obtain a satisfactory solution, we perform several runs with different initial conditions and return the solution giving the highest log-likelihood over all the runs. Now we consider the computational complexity of the EM algorithm. For each iteration, the cost consists of two parts. The first part is from the calculation of q+ ijrs and ijrs using Eq. (6), whose time complexity is O(m × c2). q− Here m is the edges in the network and c is the number of groups. The second part is from the estimation of the model parameters using Eq. (8), whose time complexity is also O(m × c2). We use T to denote the number of iterations before the iteration process converges. Then, the total cost of the EM algorithm for our model is O(T × m × c2). It is difficult to give a theoretical estimation to the number T of iterations. Generally speaking, T is determined by the network structure and the initial condition. B. Soft partition and overlapping structures The parameters, obtained by fitting the model to the observed network structure with the E-M algorithm, pro- vide us useful information for the mesoscopic structure in a given network. Specifically, the matrices ω+ and ω−, an analogy with the image graph in the role model [41], char- acterize the connecting patterns among different groups, which determine the type of structural patterns. Fur- thermore, θ and φ indicate the centrality of a vertex in its groups from the perspective of outgoing edges and incoming edges, respectively. Consequently, the proba- bility of vertex i drawn from group r when it is the tail of edges can be defined as (cid:80) (cid:80) rs + ω− rs + ω− rs)θri rs)θri s(ω+ rs(ω+ and vertex i can be simply assigned to the group r∗ to which it most likely belongs, i.e., r∗ = arg maxr{αir, r = 1, 2, . . . , c}. The result gives a hard partition of the signed network. In fact, the set of scalars {αir}c r=1 supply us with the probabilities that vertex i belongs to different groups, which can be referred to as the soft or fuzzy member- ships. Assigning vertices to more than one group have attracted by far the most interest, particularly in over- lapping community detection [8, 16–18]. The vertices be- longing to several groups, are found to take a special role in networks, for example, signal transduction in biologi- cal networks. Furthermore, some vertices, considered as “instable” [16], locate on the border between two groups and thus are difficult to classify into any group. It is of great importance to reveal the global organization of a signed network in terms of overlapping mesoscopic struc- tures and to find the instable vertices. We employ here the bridgeness [17] and group entropy [20] to capture the vertices’ instabilities and to extract the overlapping mesoscopic structure. These two measures of vertex i are computed as (cid:19)2 (cid:18) c(cid:88) r=1 αir − 1 c bi = 1 − (cid:118)(cid:117)(cid:117)(cid:116) c ξi = − c(cid:88) c − 1 r=1 αir logc αir. (11) Note that vertex i has a large bridgeness bi and entropy ξi when it most likely participates in more than one group simultaneously and vice versa. From the perspective of incoming edges, we can represent the probability of ver- tex j belonging to group s by (cid:80) (cid:80) rs + ω− rs + ω− r(ω+ rs(ω+ rs)φsj rs)φsj βjs = . (12) These statements for αir also apply to βjs. So we don’t need to repeat again. The model described above focus on directed networks. Actually, the model could be easily generalized to undi- rected networks by letting the parameter θ be identical to φ. The derivation follows the case of directed networks and the results are the same to Eq. (6) and (8). C. Model selection So far, our model assumes that the number of groups c is known as a prior. This information, however, is un- available for many cases. It is necessary to provide a criterion to determine an appropriate group number for a given network. Several methods have been proposed to deal with this model selection issue. We adopt the min- imum description length (MDL) principle, which is also , (10) A. Synthetic networks utilized in the previous generative models for network structure exploration [25]. 5 According to MDL principle, the required length to describe the network data comprises two components. The first one describes the coding length of the net- work, which is −L for directed network and −L/2 for undirected network. The other gives the length rs − sj lnφsj for directed network ri lnθri for undirected network. The optimal c is the one which minimizes the total description length. for coding model parameters that is −(cid:80) (cid:80) and −(cid:80) rs lnω− ri lnθri −(cid:80) rs −(cid:80) rs −(cid:80) rs −(cid:80) rs lnω− rs lnω+ rs lnω+ IV. EXPERIMENTAL RESULTS In this section, we extensively test our SSBM model on a series of synthetic signed networks with various known structure, including community structure and disassor- tative structure. After that, the method is also applied to three real-life social networks. The ad hoc networks, designed by Girvan and New- man [12], have been broadly used to validate and com- pare community detection algorithms [14–16, 20]. By contrast, there exists no such benchmark for community detection in networks with both positive and negative links. We generate the signed ad hoc networks with con- trolled community structure by the method developed in Refs. [34, 42]. The networks have 128 vertices, which are divided into four groups with 32 vertices each. Edges are placed randomly such that they are positive within groups and negative between groups, and the average de- gree of a vertex to be 16. The community structure is controlled by three parameters, pin indicating the prob- ability of each vertex connecting to other vertices in the same group, p+ the probability of positive links appear- ing between groups, and p− the probability of negative links arising within groups. Thus, the parameter pin reg- ulates the cohesiveness of the communities and the re- maining parameters p+ and p− add noise to the commu- nity structure when pin is fixed. For the synthetic networks, we simply consider their hard partition as defined in Sec. III B. The results are evaluated by the normalized mutual information (NMI) [43], which can be formulated as c(cid:80) c(cid:80) i=1 j=1 NMI(C1, C2) = (cid:115) c(cid:80) ( i=1 nijln nij n n(1) i n(2) j c(cid:80) i=1 n(1) i ln n(1) i n )( n(2) i ln n(2) n ) i where C1 and C2 are the true group assignment and the assignment found by the algorithms, respectively, n is the 6 and smaller. For example, the NMI of the FEC algorithm begins to drop once pin exceeds 0.8, and then quickly re- duces to less than 0.2 when pin = 0.5 and even to approx- imately 0 when pin is smaller than 0.3. Similar perfor- mances can be observed for the MMax and PMMax ap- proaches as well. These results are quite understandable since both the SSBM model and the GMMax method consider the contribution made by the negative links in signed networks, which is either neglected or removed in the remaining three approaches. This highlights the im- portance of the negative edges for community detection in the signed networks. Moreover, the PMMax method always outshines the MMax method, especially when pin in the range 0 ≤ pin ≤ 0.5, which is in agreement with the results reported in Ref. [42], indicating that the posi- tive links in signed networks have a significant impact on community detection. Then, we fix the parameter pin = 0.8 and gradually change other two parameters p+ and p− from 0 to 0.5, respectively. Clearly, all the synthetic networks are not balanced in this setting. The results obtained by our model and two updated algorithms are give in the up- per row of Fig 3. As we can see, the SSBM model con- sistently, and sometimes significantly, outperforms the other two approaches. More specifically, its NMF is al- ways 1 expect for a few negligible perturbations. By con- trast, the FEC algorithm cannot offer a satisfactory par- tition of the signed networks when 0 ≤ p+ ≤ 0.3 and 0 ≤ p− ≤ 0.5, whose NMI is less than 0.4 at all times. When 0.3 ≤ p+ ≤ 0.5 and 0 ≤ p− ≤ 0.5, the GMMax ap- proach exhibits a competitive performance, but its NMI suddenly collapses and continuously decreases once p+ is larger than 0.3. We turn now to the second experiment in which the synthetic networks have the controlled disassortative structure. The signed networks are generated in the same way, expect that we randomly place negative links within groups and positive links between groups. Simi- larly, the disassortative structure in these networks are controlled by three parameters again. pin indicates the probability of each vertex connecting to other vertices in the same group, p+ the probability of positive links ap- pearing within groups, and p− the probability of negative links arising between groups. We first study the balanced networks by setting p+ and p− to be zero and changing pin from 1 to 0 once again. As shown in Fig. 2(b), the FEC algorithm, the MMax method and our model achieve the performances that is very similar to those in the first experiment. That is, our model always successfully find the clusters in the synthetic networks for all the cases, while the FEC algo- rithm and the MMax method perform fairly well when pin is large enough, but quickly degrade as pin approaches 0. The PMMax and the GMMax methods, however, per- form rather badly. The NMI of the PMMax method seems no greater than 0.5 even if pin = 1, while the NMI of the GMMax approach nearly vanishes for all the cases. This is because the two methods, which seek stan- FIG. 2: (Color online) NMI of our method and other ap- proaches on balanced ad-hoc networks with controlled com- munity structure (a) and disassortative structure (b). Each point is an average over 50 realizations of the networks. number of vertices, nij is the number of vertices in the known group i that are assigned to the inferred group j, n(1) is the number of vertices in the true group i, n(2) i is the number of vertices in the inferred group j. The larger the NMI value, the better the partition obtained by the algorithms. j We conduct two different experiments. First, we set the two parameters p+ and p− to be zero and gradually change pin from 1 to 0. In this situation, all the gener- ated synthetic networks are 4-balanced. Fig. 2(a) reports the experimental results obtained by our method and two state-of-the-art approaches, namely generalized modular- ity maximization through simulated annealing (denoted by GMMax) [35, 36] and the finding and extracting com- munity (FEC) method [34]. In addition, we also imple- ment the simulated annealing algorithm to maximize the standard modularity by ignoring the sign of the links (denoted by MMax) and removing the negative edges (denoted by PMMax), respectively. Each point in the curves is an average over 50 realization of the synthetic random networks. Bear in mind that the community structure becomes less cohesive as the parameter pin de- creases from 1 to 0. We can see that both the SSBM model and the GMMax method perform fairly well and are almost able to perfectly recover the communities in the synthetic networks for all cases. When 0 ≤ pin ≤ 0.1, our model is even slightly superior to the GMMax ap- proach. The remaining three methods, however, can only achieve promising results when pin is sufficiently large. They all show a fast deterioration as pin becomes smaller 00.10.20.30.40.50.60.70.80.9100.20.40.60.81pinNMI(a) 00.10.20.30.40.50.60.70.80.9100.20.40.60.81pinNMI(b) FECMMaxPMMaxGMMaxSSBMMMinPMMinGMMin 7 FIG. 3: NMI on unbalanced ad-hoc networks with controlled community structure (first row) for (a) FEC, (b) GMMax and (c) SSBM, and with controlled disassortative structure (second row) for (d) FEC, (e) GMMin and (f) SSBM. Each point is an average over 50 realizations of the networks. dard and generalized modularity maximization, respec- tively, are suitable only for community detection. As a consequence, they deserve to suffer a serious failure in this experiment. Instead, one should minimize the modularity to uncover the multipartite structure in net- works, as indicated in Ref. [10]. Therefore, we apply the simulated annealing algorithm to minimize the gen- eralized modularity (denoted by GMMin) and the stan- dard modularity by ignoring the sing of links (denoted by MMin) and excluding the negative connections (de- noted by PMMin), respectively. We see from Fig. 2(b) that the GMMin method can obtain competitive perfor- mance with our SSBM model expect for a slight inferior when 0 ≤ pin ≤ 0.1. However, the MMin and the PMMin approaches perform unsatisfactorily due to the fact that they do not consider the contributions derived from the negative links. We investigate next the disassortative structure in un- balanced synthetic networks by fixing pin = 0.8 and changing p+ and p− from 0 to 0.5 step by step. The lower row of Fig. 3 gives the results obtained by the FEC method, the GMMin approach and our SSBM model, which are quite similar to those in the first experiment. In particular, although the SSBM does not perform per- fectly in some cases, its NMF is still rather high, say, more than 0.98. When 0 ≤ p− ≤ 0.3, the GMMin ap- proach yields sufficiently good results, but its NMF re- duces at a very fast speed along with p− toward 0.5. The FEC algorithm achieves the worst performance in all cases. Finally, we focus on a synthetic network containing a multitude of mesoscopic structures, whose adjacency matrix is given in Fig. 4(a). Intuitively, according to the outgoing edges in this network, the second group is the community structure and the third group belongs to the disassortative structure. The first group with posi- tive outgoing links only, can be viewed as an example of the standard community structure in positive networks, while the last group, which includes only negative outgo- ing links, can be referred to as an extreme example of the disassortative structure in signed networks. Meanwhile, from the perspective of incoming edges, the four groups exhibit different types of structural patterns, which can- not be categorized simply as community structure or dis- assortative structure. We apply the FEC algorithm, the GMMax method, the GMMin method and our model to this signed network. Limited by their intrinsic assump- tions, the FEC algorithm, the GMMax method and the GMMin method fail to uncover the structural patterns, as shown in Fig. 4(b)-(d). In particular, the general- ized modularity proposed in Refs. [35, 36], regardless of whether it is maximum or minimum, misleads us into receiving an improper partition of the network in which the four groups merge with each other. But by dividing vertices with the same connection profiles into groups, our model could accurately detect all types of mesoscopic structures, both from the perspective of outgoing links (Fig. 4(e)) and from the perspective of incoming edges 00.10.20.30.40.500.10.20.30.40.500.20.40.60.81p+(a)p−NMI00.10.20.30.40.500.10.20.30.40.50.20.40.60.81p+(b)p−NMI00.10.20.30.40.500.10.20.30.40.50.980.991 p+(c)p− NMI00.10.20.30.40.500.10.20.30.40.500.20.40.60.81p−(d)p+NMI00.10.20.30.40.500.10.20.30.40.50.20.40.60.81p−(e)p+NMI00.10.20.30.40.500.10.20.30.40.50.980.991p−(f)p+NMI00.10.20.30.40.50.60.70.80.91 8 FIG. 4: (Color online) Detecting the mesoscopic structure of a synthetic network. (a) The adjacency matrix of the signed network where the black dots denote the positive links and the gray dots represent the negative edges. The partitioning results for different methods (b) EFC, (c) GMMax, (d) GMMin and SSBM from the perspective of outgoing edges (e) and incoming edges (f), where the solid edges denote the positive links and the dashed edges represent negative links. The sizes of the vertices in (e) and (f) indicate their centrality degree in the corresponding groups according to the parameters θ and φ, respectively. B. Real-life networks We further test our method by applying it to several real networks containing both positive and negative links. The first network is a relation graph of 10 parties of the Slovene Parliamentary in 1994 [44]. The weights of links in the network were estimated by 72 questionnaires among 90 members of the Slovene National Parliament. The questionnaires were designed to estimate the dis- tance of the ten parties on a scale from -3 to 3, and the final weights were the averaged values multiplied by 100. We further test our method by applying it to several real networks containing both positive and negative links. The first network is a relation graph of 10 parties of the Slovene Parliamentary in 1994 [44]. The weights of links in the network were estimated by 72 questionnaires among 90 members of the Slovene National Parliament. The questionnaires were designed to estimate the dis- tance of the ten parties on a scale from -3 to 3, and the final weights were the averaged values multiplied by 100. Applying our model to this signed network, we find that the MDL achieves its minima when c = 2, as shown in Fig. 5(a), indicating that there are exactly two com- munities in the network. Fig. 6(a) gives the partition obtained by our method, which divides the network into two groups of equal size and produces a completely con- FIG. 5: Model selection results for (a) the Slovene Parliamen- tary network, (b) the Gahuku-Gama Subtribes network and (c) the international conflict and alliance network. (Fig. 4(f)). Furthermore, the obtained parameters θ and φ reveal the centrality of each vertex in its corresponding group from the two perspectives. 2040608010012020406080100120(a)(b)(c)(d)(e)(f)234562.52.552.62.652.72.75x 104Group number cDescription length(a)23456310320330340Group number cDescription length(b)3456789108.88.999.19.29.3x 104Group number cDescription length(c) TABLE I: The soft group membership α, bridgeness bi [17] and group entropy ξi [20] of each vertex in the Slovene Parliamentary network [42]. Larger bridgeness or entropy means that the corresponding node are more “instable”. 9 Vertex SKD ZLSD SDSS LDS ZS-ESS ZS DS 0 1.000 1.000 1.000 0 0 0 0 0 0 1.000 0 0 0 0 0 1.000 1.000 0 0 0 0 0 0 0 1.000 0 0 αi1 αi2 bi ξi 1.000 SLS SPS-SNS SNS 0.0186 1.000 0.9814 0.0372 0.1334 0 0 0 0 0 0 TABLE II: The soft group membership α, bridgeness bi [17] and group entropy ξi [20] of each vertex in the Gahuku-Gama Subtribes network [45]. Larger bridgeness or entropy means that the corresponding node are more “instable”. Vertex GAVEV KOTUN OVE ALIKA NAGAM GAHUK MASIL UKUDZ NOTOH KOHIK αi1 αi2 αi3 bi ξi 1.000 1.000 0 0 0 0 0 0 0 0 0 0 1.000 1.000 0 0 0 0 0 0 0 0 1.000 0 0 0 1.000 0 0 0 0 0.7143 0.2857 0.3773 0.5446 0 1.000 0 0 0 0 0 0 0 1.000 1.000 0 0 0 0 Vertex GEHAM ASARO UHETO SEUVE NAGAD GAMA 1.000 1.000 0 0 αi1 αi2 αi3 bi ξi 0 0 0 0 1.000 1.000 0 0 0 0 0 0 1.000 1.000 0 0 0 0 0 0 0 0 0 0 0 0 ent groups.1 From Table I, we see that all the vertices can be exclusively separated into two communities, ex- pect for the vertex “SNS” which belongs to the circle group with probability 0.0186 and to the square group with probability 0.9814. In other words, the two commu- nities overlap with each other at this vertex, resulting in its high bridgeness of 0.0372 and group entropy of 0.1334. This is validated by the observation that the vertex has two negative links with vertices “ZS-ESS” and “DS” in the same community. We also visualize the learned pa- rameters ω+ and ω− in Fig. 6(b), which indeed provide a coarse-grained description of the signed network and reveal that this network actually has two communities. The second network is the Gahuku-Gama Subtribes network, which was created based on Read’s study on the cultures of Eastern Central Highlands of New Guinea [45]. This network describes the political al- liance and enmities among the 16 Gahuku-Gama sub- tribes, which were distributed in a particular area and were engaged in warfare with one another in 1954. The positive and negative links of the network correspond to political arrangements with positive and negative ties, respectively. Fig. 5(b) tells us that this signed network consists of three groups because the MDL of the SSBM model is minimum when c = 3. The three groups cat- egorized by our model are given in Fig. 7(a), and they 1 This network as well as the Gahuku-Gama Subtribes network are both undirected graph, and therefore the parameter α is identical to β, and θ is identical to φ. FIG. 6: Exploratory analysis of the Slovene Parliamentary network [44]. The solid edges denote the positive links and the dashed edges represent negative links. The true commu- nity structure in this network is represented by two different shapes, circle and square. The shades of nodes indicate the membership α obtained by fitting our model to this network. The sizes of the vertices, proportional to θ, indicates their centrality degree with respect to their corresponding group. sistent split with the true communities in the network. As expected, vertices within the same community are mostly connected by positive links while vertices from different communities are mainly connected by negative links. We shade each vertex proportional to the pa- rameters {αir}c r=1, the magnitude of which supplies us with the probabilities of each vertex belonging to differ- SKDZLSDSDSSLDSZS-ESSZSDSSLSSPS-SNSSNS0.360.64-112(a)(b) 10 in several existing studies. These studies indicated that there are six main power blocs, each consisting of a set of countries with similar actions of alliances or disputes. In Ref. [36], the authors labeled these power blocs as (i) The West, (ii) Latin America, (iii) Muslim World, (iv) Asia, (v) West Africa, and (vi) Central Africa. Apply- ing the SSBM model to this network, we find that the MDL arrives its minimum when c = 6, as illustrated in Fig. 5(c). By partitioning the network into six groups, we summarize the results in Fig. 8. From the rearranged adjacency matrix [Fig. 8(c)], we can conclude that the first, second, third and fifth groups, from bottom left to top right, distinctly belong to the community structure, while the sixth group can be viewed as the disassortative structure. However, the fourth group cannot be simply categorized as either community structure or disassor- tative structure. In agreement with the assumption of the SSBM model, vertices in the six groups exhibit the similar connection profiles, although the miscellaneous structural patterns coexist in this network. From the perspective of the outgoing edges, we ob- tain a split of the network that is similar to the one got in Ref. [36], as shown in Fig. 8(a). However, sev- eral notable difference exists between the two results. Specifically, “Pakistan” is grouped with the West and “South Korea” is grouped with the Muslim World in Ref. [36]. These false categorizations can be correctly amended, which is consistent with the configuration de- picted in Huntington’s renowned book The Clash of Civ- ilizations [46]. In addition, we categorized “Australia”, which is grouped with West in Ref. [36], into the group Asia for understandable reasons. Fig. 8(b) gives a quite different structure of this network from the perspective of incoming edges. Three groups, namely the West, Latin America and Muslim World, stay almost the same. But “Russia”, together with some countries of the former So- viet Union, are isolated from the Asia group and form an- other independent power bloc. Meanwhile, the remaining countries in Asia group join with the West Africa coun- tries to constitute a bigger cluster. It is not difficult to see that all the changes appear to be in accordance with the history and evolution of the international relations. Recall that the parameters θ and φ provide us with the centrality degrees of each vertex in its corresponding group from the perspective of outgoing edges and incom- ing edges, respectively. In other words, the parameters measure the importance of each vertex in its group. For a better visualization, the sizes of vertices in Fig. 8(d) and (e) are proportional to the magnitude of the scalars θ and φ. Coincidentally, we discover that the big ver- tices, marked by the red bold border, usually stand for the dominant countries in their corresponding groups. For example, the largest vertex of the West is “USA” in Fig. 8(d). In fact, this state often serves as a leader in its power bloc. A similar interpretation can be given for the vertex “Russia” in Asia group. We further check the bridgeness and group entropy for each vertex in the net- work (data not shown), and we mark the vertices, which FIG. 7: (Color online) Exploratory analysis of the Gahuku- Gama Subtribes network [45]. The solid edges denote the positive links and the dashed edges represent negative links. The true community structure in this network is represented by three different shapes while the inferred groups are denoted by different colors. The sizes of the vertices are proportional to the parameters θ. match perfectly with the true communities in the signed network. As shown in Table II, the vertex “MASIL” par- ticipates in the circle group with probability 0.7143 and in the square group with probability 0.2857. As a result, it has a large value of bridgeness 0.3773 and group en- tropy 0.5446. This implies that these two groups overlap with each other at this vertex, which is approved by the fact that the vertex “MASIL”has two positive links con- nected to “NAGAM” and “UHETO”, respectively. The learned parameters ω+ and ω− supply us with a thumb- nail of the signed network again in Fig. 7(b). Finally we test our model on the network of interna- tional relation taken from the Correlates of War data set over the period 1993—2001 [36]. In this network, positive links represent military alliances and negative links denote military disputes. The disputes are asso- ciated with three hostility levels, from “no militarized action” to “interstate war”. For each pair of countries, we chose the mean level of hostility between them over the given time interval as the weight of their negative link. The positive links denote the alliances: 1 for en- tente, 2 for non-aggression pact and 3 for defence pact. Finally, we normalized both the negative links and pos- itive links into the interval [0, 1] and the final weight of the link among each pair of countries is the remainder of the weight of the normalized positive links subtracting the weight of the normalized negative links. The ob- tained network contains a giant component consisting of 161 vertices (countries) and 2517 links (conflicts or al- liances). Here, we only investigate the structure of the giant component. The structure of this network has been investigated GAVEVKOTUNOVEALIKANAGAMGAHUKMASILUKUDZNOTOHKOHIKGEHAMASAROUHETOSEUVENAGADGAMA0.210.520.28-0.38-0.38-0.24123(a)(b) 11 FIG. 8: (Color online) Exploratory analysis of the international conflict and alliance network [36]. Maps of the groups found using the SSBM model from the perspective of outgoing edges (a) and incoming edges (b). (c) The rearrange adjacency matrix, in which the black dots denote positive links and the gray dots represent negative edges, respectively. Six groups are separated by black solid lines. The partition of this network obtained by the SSBM model from the perspective of outgoing edges (d) and incoming edges (e), where the solid edges denote the positive links and the dashed edges represent negative links. The sizes of vertices are respectively proportional to their centrality degree θ and φ. The red bold border vertices have the large centrality degrees while the black bold border vertices have the large values of bridgeness and group entropy. have large values of these two measures, with the black bold border. As anticipated, these kinds of vertices are particularly prone to reside on the boundaries of differ- ent groups. That is to say, the vertices that are very difficult to divide into one group build a fuzzy watershed of the overlapping structures. In Fig. 8(b), three vertices “Janpan” , “Philippines” and “Australia”, with high val- ues of bridgeness and group entropy, play a transitional role between the West and Asia groups. In reality, the above-mentioned Asian counties frequently collaborated with the counterparts in West group in many areas, from economics to military. V. CONCLUSIONS We propose an extension of the stochastic block model to study the mesoscopic structural patterns in signed net- works. Without prior knowledge what specific structure exists, our model can not only accurately detect broad types of intrinsic structures, but also can directly learn their types from the network data. Experiments on a number of synthetic and real world networks demon- strate that our model outperforms the state-of-the-art approaches at extracting various structural features in a given network. Due to the flexibility inherited from the stochastic model, our method is an effective way to re- WestLatinyAmericaMuslimyWorldAsiaWestyAfricaCentralyAfricaWestLatinyAmericaMuslimyWorldAsiaWestyAfricaCentralyAfricaWestLatinyAmericaMuslimyWorldAsiaWestyAfricaCentralyAfricaWestLatinyAmericaMuslimyWorldAsiayEyCentralyAfricaWestyAfricaSovietyUnionWestLatinyAmericaMuslimyWorldAsiayEyCentralyAfricaWestyAfricaSovietyUnionWestLatinyAmericaMuslimyWorldAsiayEyCentralyAfricaWestyAfricaSovietyUnionCentralyAfricaAsiaMuslimWorldLatinAmericaWestWestAfricaSovietUnionWestLatinAmericaMuslimWorldAsiaWestAfricaCentralAfricaUSACanadaRussiaMauritaniaNigeriaDemocraticyRepublicyofytheyCongoTanzaniaAngolaMozambiqueZambiaSudanSyriaOmanJapanPhilippinesAustraliaUSACanadaHaitiChileYugoslaviaBosniayandyHerzegovinaRussiaArmeniaGeorgiaAzerbaijanMauritaniaNigerLiberiaNigeriaEthiopiaAngolaZambiaSudanSyriaYemenTajikistanKyrgyzstanKazakhstanGajGbjGcjGdjGej work used in this paper. The author is also grateful to the anonymous reviewers for their valuable suggestions, which were very helpful for improving the manuscript. 12 veal the global organization of the networks in terms of the structural regularities, which further helps us under- stand the relationship between networks’ structure and function. As future work, we will generalize our model by releasing the requirement that the block matrices are square matrices and investigate the possible applications of the more flexible models. Acknowledgments The author would like to thank Vincent A. Traag for providing the international conflict and alliance net- [1] M. E. J. Newman, SIAM Review 45, 167 (2003). [2] M. A. Porter, J.-P. Onnela and P. J. Mucha, Notices of the American Mathematical Society 56, 1082 (2009). [3] S. Fortunato, Phys. Rep. 486, 75 (2010). [4] G. Palla, A.-L. Barab´asi, and T. Vicsek, Nature 446, 664 (2007). [5] A. L. Traud, E. D. Kelsic, P. J. Mucha, and M. A. Porter, SIAM Review 53, 526 (2011). [6] G. W. Flake, S. R. Lawrence, C. L. Giles, and F. M. Co- etzee, IEEE Computer 35, 66 (2002). [7] R. Guimer`a and L. A. N. Amaral, Nature 433, 895 (2005). [8] G. Palla, I. Der´enyi, I. Farkas, and T. Vicsek, Nature 435, 814 (2005). [26] T. P. Peixoto, Hierarchical block structures and high- resolution model selection in large networks. Phys. Rev. X 4, 011047 (2014). [27] A. Decelle, F. Krzakala, and L. Zdeborova, Inference and Phase Transitions in the Detection of Modules in Sparse Networks. Phys.Rev. Lett. 107, 065701 (2011). [28] A. Clauset, C. Moore and M. E. J. Newman, Hierarchical structure and the prediction of missing links in networks. Nature 453, 98 (2008). [29] R. Guimera and M. Sales-Pardo, Missing and spurious interactions and the reconstruction of complex networks. Proc. Nat. Acad. Sci. U.S.A. 106, 22073 (2009). [30] F. Lorrain and H. C. White, J. Math. Sociol. 1, 49 (1971). [31] J. Reichardt and D. R. White, European Physical Jour- [9] M. Huss and P. Holme, IET Syst. Biol. 1, 280 (2007). nal B 60, 217 (2007). [10] M. E. J. Newman, Phys. Rev. E 74, 036104 (2006). [11] M. E. J. Newman and E. A. Leicht, Proc. Nat. Acad. Sci. [32] M. J. Mason, G. Fan, K. Plath, Q. Zhou and S. Horvath, BMC Genomics 10, 327 (2009). U.S.A., 104, 9564 (2007). [33] G. Facchetti, G. Iacono, and C. Altafini, Phys. Rev. E [12] M. Girvan and M. E. J. Newman, Proc. Natl. Acad. Sci. 86, 036116 (2012). U.S.A. 99, 7821 (2002). [34] B. Yang, W. K. Cheung, and J. M. Liu, IEEE Trans. [13] P. Holme, F. Liljeros, C. R. Edling, and B. J. Kim, Phys. Knowl. Data Eng. 19, 1333 (2007). Rev. E 68, 056107 (2003). [35] S. G´omez, P. Jensen, A. Arenas, Phys. Rev. E 80, 016114 [14] M. E. J. Newman and M. Girvan, Physical Review E 69, (2009). 026113 (2004). [36] V. A. Traag and J. Bruggeman, Phys. Rev. E 80, 036115 [15] L. Danon, J. Duch, A. Diaz-Guilera, and A. Arenas, J. (2009). Stat.Mech. 9, P09008 (2005). [37] M. Szell, R. Lambiotte and S. Thurner, Proc. Natl. Acad. [16] D. Gfeller, J. C. Chappelier, and P. DeLosRios, Phys Rev Sci. U.S.A. 107, 13636 (2010). E 72, 056135 (2005). [17] T. Nepusz, A. Petr´oczi, L. Negyessy and F. Bazs´o, Phys. Rev. E 77, 016107 (2008). [38] F. Heider, J. Psychol. 21, 107 (1946). [39] J. A. Davis, Hum. Relat. 20, 181 (1967). [40] D. Cartwright and F. Harary, Elemente der Mathematik [18] I. Psorakis, S. Roberts, M. Ebden, and B. Sheldon, Phys- 23, 85 (1968). ical Review E 83, 066114 (2011). [41] J. Reichardt and S. Bornholdt, Phys. Rev. E 74, 016110 [19] C. Granell, S. G´omez, and A. Arenas, Chaos 21, 016102 (2006). (2011). [20] J.Q. Jiang and L.J. McQuay, Physica A 391, 854 (2012). [21] P. W. Holland, K. B. Laskey, and S. Leinhardt, Social Networks 5, 109 (1983). [22] B. Karrer and M. E. J. Newman, Phys. Rev. E 83, 016107 (2011). [23] T. Yang, Y. Chi, S. Zhu, Y. Gong, and R. Jin, Machine Learning 82, 157 (2011). [24] E. M. Airoldi, D. M. Blei, S. E. Fienberg, and E. P. Xing, J. Mach. Learn. Res. 9, 1981 (2008). [25] H. W. Shen, X. Q. Cheng, and J. F. Guo, Physical Re- view E 84, 056111 (2011). [42] T. D. Kaplan and S. Forrest, arXiv:0801.3290 (2008). [43] A. Strehl and J. Ghosh, J. Mach. Learn. Res. 3, 583 (2002). [44] S. Kropivnik and A. Mrvar, An analysis of the Slovene parliamentary parties network, Developments in Statis- tics and Methodology, 209–216 (1996). [45] K. E. Read, Southwestern J. Anthropology, 10, 1 (1954). [46] S. P. Huntington,The clash of civilizations and the re- making of world order (Simon & Schuster, New York, 1996).
1010.5377
1
1010
2010-10-26T12:32:10
Estimating Network Parameters for Selecting Community Detection Algorithms
[ "cs.SI", "physics.soc-ph" ]
This paper considers the problem of algorithm selection for community detection. The aim of community detection is to identify sets of nodes in a network which are more interconnected relative to their connectivity to the rest of the network. A large number of algorithms have been developed to tackle this problem, but as with any machine learning task there is no "one-size-fits-all" and each algorithm excels in a specific part of the problem space. This paper examines the performance of algorithms developed for weighted networks against those using unweighted networks for different parts of the problem space (parameterised by the intra/inter community links). It is then demonstrated how the choice of algorithm (weighted/unweighted) can be made based only on the observed network.
cs.SI
cs
Estimating Network Parameters for Selecting Community Detection Algorithms Leto Peel Advanced Techno logy Centre, BAE Systems, Bristol, UK leto.pee [email protected] Abstract – This paper considers the problem of algo rithm selection for community detection. The aim of community detection is to identify sets of nodes in a network which are more interconnected relative to their connectivity to the rest of the network. A large number of algorithms have been developed to tackle this problem, but as w ith any machine learning task there is no “one-size-fits-all ” and each algorithm excels in a specific part of the problem space. This paper examines the performance of algorithms developed for weighted networks against those using unweighted networks for different parts of the problem space (parameterised by the intra/inter community links) . It is then demonstrated how the choice of algorithm (weighted/unweighted) can be made based only on the observed network. Keywords: Community detection, algorithm selection, interaction networks. 1 Introduction The study of large scale networks has revealed a number of properties about the behav iour and topology of naturally occurring networks. One such property is the presence of community structures; sets of nodes in a network which are more interconnected relative to their connections to the rest of the network. The aim of community detection is to identify these structures. Community detection is a problem which has attracted much interest in recent years [1-5] and has consequently produced a wide range of approaches to the problem; an in-depth rev iew of most contemporary methods is giv en in [6]. One of the reasons why the abil ity to detect communities is so attractiv e l ies in the phenomenon known as assortative mixing, where entities in a network are observ ed to associate preferential ly with sim i lar entities. This suggests that detecting communities may be used for identifying entities which share common attributes or purposes. An example of community structures corresponding to entity sim ilarity is giv en in [7] where community structures in a f riendship network identify sim i larities in race and age. The wide range of complex systems that can naturally be expressed as networks (human interaction patterns, metabol ic networks, WWW , the brain) implies that community detection has appl ications spanning domains as diverse as biology [8-10], sociology [8],[11],[12], computer science [13],[14] and intel ligence [15-17]. The implications of community detection in the intel ligence domain are that it could be used to identify groups of people who share common goals or purposes. To this ef fect, community detection could potential ly be used to constrain the inference problem when inv estigating or detecting mal icious activ ities, e.g. rather than monitoring al l people, use community detection as a pre-processing step to select a subset of people to monitor. In this setting, the network nodes would represent people and the l inks would represent interactions or relationships between them; such a network can be constructed f rom a database of phone records, email logs or other transactional data. W ith a large selection of algorithms avai lable to undertake the task of community detection, choosing an appropriate algorithm becomes problematic. This is largely due to the lack of formal or commonly accepted evaluation procedures. The networks used to ev aluate community detection tend to be a smal l selection of real networks and/or networks generated f rom simple models, where these networks v ary widely between authors. Recent work to address this has focused on dev eloping benchmark networks [18] on which comparative analysis [19] can be drawn to determ ine the rel iabil ity of dif ferent algorithms. However, it is commonly accepted across the machine learning community that there is no one-size-fits-all solution and so this work considers the idea that for dif ferent situations, dif ferent classes of algorithms may outperform other classes of algorithms. The range of community detection algorithms in itself poses the intell igence analyst with the challenge of choosing an appropriate solution or combinations of solution techniques for the specific problem at hand. It is therefore desirable to be able to prov ide the intel l igence analyst, who wi ll l ikely not have expert knowledge of these algorithms, with appropriate guidance. This paper considers the problem of automatical ly selecting community detection algorithms based on observ ations of the community structure. It has been prev iously observed how structural properties of communities af fect the performance of community detection algorithms [19]. These properties cannot be measured from the network data alone as they require knowledge of the underlying community assignment. The main contribution of this work is to demonstrate how these structural properties can be estimated from features of the observ ed network. Therefore a prediction about which algorithm wil l perform best can be made. This is achieved by considering algorithms for weighted networks and algorithms for unweighted networks as two separate classes and demonstrating how the performance of these two classes dif fers across the problem space (defined in section 2). F inal ly, a Support Vector Machine (SVM) [20] is used to classify the networks according to the algorithm which wi l l perform best. The rest of the paper is organised as fol lows: Section 2 defines the problem space by defining the network and community structure types and the target algorithm classes. The performance of the algorithm classes with respect to the structural parameters is evaluated in Section 3. Section 4 describes the observable network parameters and how a mapping can be made f rom these to the underlying structural parameters. The results of using the observable parameters to choose an appropriate class of algorithm are given in Section 5. Conclusions are given in Section 6. 2 Problem Space A network is a structure made up of nodes, representing entities, and l inks or edges, representing relationships or interactions between entities. The total number of l inks connected to a node is known as its degree. The network l inks may also have weights associated with them which may represent the relative importance of the link. For example, in an interaction network representing a phone record database, the nodes would represent people and the links phone cal ls. The l ink weights could then represent the f requency of cal ls. Network l inks may also be directed, but this wi ll not be considered in this work. The prem ise of community detection is that there is some underlying assignment of nodes to communities which has to be discovered. But despite the large amount of literature on the subject there is sti l l a lack of agreement on what def ines a community beyond the intuitive concept that community structures have more intra-community l inks than inter-community links. W ithout a common definition it is dif ficult to draw a comparison between algorithms. However, it may not be necessary (or even desirable) to define a specific common definition of community, as def initions may be dependent on the application. Instead perhaps a suitably comprehensiv e parameter set for describing the space of community types and structures of interest. A reasonable starting point is the parameter set used to generate networks and communities using the Lancichinetti-Fortunato-Radicchi (LFR) benchmark generator [18] as not only do these describe a number of network properties, but by using the generator it is possible to obtain networks and community assignments with those properties. This parameter set is described in section 2.1. 2.1 Network-Community Parameterisation The parameter set used to describe the problem space are the parameters used by the LFR benchmark which is fully described in [18]. The LFR benchmark was designed to generate datasets to test community detection algorithms and m im ic the observ ed properties of large-scale real complex networks [21], such as power-law degree and community distribution. The parameters are best described in the contex t of the graph generation procedure: 1. N nodes are assigned to communities such that the community size distribution conforms to a power- law with m inus exponent τ2. 2. Each node is assigned a degree such that the degree distribution conforms to a power law with m inus exponent τ1 and mean degree k. 3. Links are initially assigned random ly according to the degree distribution. A topological m ixing parameter, µt, is set to def ine the proportion of each nodes l inks which l ink outside its community. Topological consistency with this parameter is achieved through an iterativ e re-wiring procedure. 4. Each node is then assigned a strength according to a power-law distribution with m inus exponent β. The strength of a node is the weighted analogy of degree and as such represents the sum of the weights of the l inks for a giv en node. 5. To assign the l ink weights a sim i lar process to step 3 is carried out according to the weight m ixing parameter, µw. It is accepted that these may not be a ful l set of parameters to comprehensively describe the space of al l possible network-community structures. Ev en so, the space is one of high dimensionality and so ful l exploration of al l the parameters is beyond the scope of this paper and remains for future work. To constrain the problem, the values of al l parameters were f ixed with the exception of µt and µw, which from initial tests were found to hav e the greatest impact on use of l ink weights. 2.2 Algorithm Overview The algorithm selection problem has been constrained to choosing between the class of algorithms which use link weight information and the class that does not. In l ight of this, it was decided to use algorithms suitable for unweighted or weighted networks. This way a control led comparison can be drawn between the performances of the unweighted and weighted algorithms without needing to worry about differences in algorithms. Two such algorithms are exam ined: • Infomap [5]: This algorithm approaches the community detection problem by identifying a duality between community detection and information compression. By using random walks to analyse the information flow through a network it identifies communities as modules through which information flows quickly and easi ly. Coding theory is used to compress the data stream describing the random walks by assigning frequently v isited nodes a shorter codeword. This is further optim ised by assigning unique codewords to network modules and reusing short codewords for network nodes such that node names are unique giv en the context of the module. This two lev el description of the path al lows a more ef f icient compression by capitalising on the fact that a random walker spends more time within a community than mov ing between communities. • COPRA [22]: This is an ex tension of the label propagation based RAK algorithm [23]. The algorithm works as fol lows; to start, al l nodes are initialised with a unique label. These labels are then updated iteratively, where a node ’s new label is assigned according to t he label used most by its neighbours. If there is more than one most f requently occurring label amongst the neighbours, then the label is chosen random ly. At term ination of the algorithm, nodes with the same label are assigned to the same community. The Community Ov erlap PRopagation Algorithm (COPRA) extends the RAK algorithm to deal with the possibil ity of ov erlapping communities (although this aspect of community detection is not explored within this work). This is done by augmenting the label with a belonging factor such that for a giv en node these sum to 1. To prevent al l nodes becom ing a member of al l communities, a threshold is set below which the labels are discarded. Due to the stochastic nature of the algorithm, particularly in the initial iterations, the algorithm is, in practise, run a number of times and the “best” community assignment is decided accord ing to the one which has the highest modularity [24]. In the weighted instance of the algorithm, the weights of the network are incorporated by weighting the f requency of the labels according to the l ink weight connecting the respectiv e node. 3 Algorithm Performance A number of dif ferent metrics are used in the l iterature to measure the performance of community detection algorithms, however the Normalised Mutual Information [1] metric is one which has become fairly standard recently and so wil l be used here. This metric prov ides a measure of sim i larity between the algorithm output assignment and the true community assignment, where a value of 1 denotes a perfect match. Experiments were run to exam ine the ef fect of varying the two m ixing parameters µt and µw, the results of which can be seen in Figure 1. Figure 1 shows the mutual information scores for the weighted algorithms (COPRAw, INFOMAPw) and unweighted algorithms (COPRAuw, INFOMAPuw) as µw is changed. The plots (a) – (d) show the perform ance for dif ferent values of µt. Each point on the graphs represents the average mutual information over 25 generated networks with the indicated parameter values. It can be seen that the unweighted algorithms perform wel l when µt is low and are unaf fected by µw for all values µt. This is only to be expected as these algorithms only rely on the topological information. The weighted algorithms on the other hand are affected by both parameters, but are seen to consistently perform wel l for low µw. The ef fect of µt is probably best observed in F igure 2. Here it can be seen that the weighted algorithms perform wel l when µt is at least as high as µw (in this case µw=0.3). A sim i lar observ ation was made in [19] where it was seen that weighted algorithms performed better overal l at µt values of 0.5, in comparison to lower v alues. It was explained that the reason for this is that a low µt relativ e to µw means that there is a lower proportion of inter-community l inks relativ e to the proportion of inter-community weights. The effect of this is that a smal l number of inter- community l inks receive high l ink weights relativ e to the intra-community weights, see Figure 3. (a) µt = 0.2 (b) µ t = 0.4 (d) µ t = 0.8 (c) µ t = 0.6 Figure 1: Mutual information scores (y-axis) as µw (x -axis) changes. Each subplot shows a dif ferent f ixed v alue for µt. The values of the other parameters were fixed: N=100, k=25, τ1=2, τ2=1, β=1.5 Figure 2: Mutual information scores for the weighted (w) and unweighted (uw) algorithms as µt is varied. The value of µw is fixed at 0.3. It is noticeable that the two classes of algorithm perform for complimentary settings of µt. Figure 3: An example node with links and weights from a network with µt = 0.2 and µw = 0.3. As a result the single inter-community l ink (orange) receives a higher weight relative to the intra-community links. The ef fect of this is that there are regions of the problem space, parameterised by community m ixing proportions, in which a weighted algorithm wil l outperform an unweighted one and v ice versa. This can be seen in Figure 2 where the two regions are label led w (weighted) and uw (unweighted). This result indicates that a choice can be made, based on the community structure, as to the class of community detection algorithm. In order to take adv antage of this information and select the best class of algorithm for a given network, some knowledge of the underlying community structure is required. It may be possible to make some assumption about the communities that are sought af ter based on some knowledge of the specif ic domain. In most community detection problems howev er, this information about the community structure is unknown. 4 Parameter Estimation In order to use the information f rom the prev ious section, it is required to know the v alues of the m ixing parameters of the communities. W ithout knowledge of the communities (i.e. prior to community detection) it is not possible to ev aluate these parameters. In this section it wi l l be shown how parameters of the observable network can be mapped to these community parameters and how these values can be used to bui ld a classif ier to determ ine the class of community detection most suitable for the giv en network. 4.1 Observable Parameters There are a range of metrics associated with describing network topology: degree distribution, average diameter, and central ity measures are a few of them. The problem here is that a parameter is required which describes the way that the community structures interact, without expl icitly knowing the community structures. To approach this, the node measure cal led clustering coef f icient [25] is considered. This is def ined as: ∑ ∈ e ij , Nji v 2/)1 ( kk − v v C ) uw = ( v , (1) ) ( uw vC , represents the proportion of the neighbours, Nv, of node v where the local clustering coef ficient, which are connected (i.e. edge eij=1 if there is a link between neighbouring nodes i and j) out of the possible connections between its neighbours, kv(kv-1)/2. It was found that the mean v alue of the local clustering coef ficient, taken over al l the nodes in the network, showed a strong correlation with the topological m ixing parameter, µt (Figure 4a). This suggests that the mean clustering coeff icient could be used to estimate this m ix ing parameter. If the mean clustering coef ficient could be used to estimate the topological m ix ing then it follows that a weighted ex tension to this may yield information about the weighted m ix ing parameter (Equation 2). ( ) ∑ w ew ∑ vi vj ij ∈ , Nji − ( )1 kw vi ∈ Ni where wv i is the weight associated with the l ink between nodes v and i. The mean of this value over the network was found to correlate with µw (Figure 4b). The results in F igure 4 suggest that the m ixing parameters can be estimated from observ ed network characteristics without knowledge of the community structure. (2) C + = ( v , w ) v v v (a) (b) Figure 4: Scatter plots of the unweighted (x-ax is) and weighted (y-ax is) mean local clustering coeff icient, (a) shows the v alue of the topology m ix ing parameter, µt. Sim i larly (b) shows the weight m ixing parameter, µw. The reason for this can be explained by considering the general principle of a community; that nodes within a community are more likely to be connected compared to overal l probabi lity of connection due to the sparse nature of the network. Hence, if two neighbours are within the same community, it is reasonable to expect them to be connected. However, if neighbours are not in the same community it is more likely that they are not connected. Based on this reasoning, the local clustering coef ficient is an estimate of the indiv idual node’s m ix ing parameter, which averaged over the network yields a global estimate. 4.2 Algorithm Classification using SVM The results of the prev ious section suggest that it is possible to estimate the m ixing parameters of the communities. Now returning to the reason why it may be useful to estimate these parameters, i.e. to determ ine the class of algorithm, it is suggested that rather than estimate the m ix ing parameters and in turn predict the algorithm class, it may be more useful to use the clustering coeff icients to directly predict the algorithm class. Figure 5 shows sim i lar plots as Figure 4, but with the colour indicating the performance for the different algorithms. It can be seen that the weighted algorithms have a distinctly different performance pattern to the unweighted ones. (a) (c) (b) (d) Figure 5: Clustering coeff icients scatter plots with colours showing the mutual information score for (a) unweighted infomap, (b) weighted infomap, (c) unweighted COPRA and (d) weighted COPRA. In order to confirm that these observable parameters can effectively predict the algorithm class, a simple classif ier was bui lt using l inear support v ector machines (SVM) [20]. To do this, each of the networks were assigned a class {weighted, unweighted, none} based on the class of algorithm which performed best in terms of its mutual information score. A class of “none” was assigned to any network where the mutual information score for the best perform ing algorithm was below some threshold. The reasoning for this is that for low performance values the output is not meaningful and therefore the choice of algorithm is irrelev ant. As SVMs are restricted to two classes, three classif iers were trained (weighted vs. unweighted, weighted v s. none, unweighted vs. none) and the predicted class obtained by using a v oting scheme over the three outputs. The results are discussed in the next section. 5 Results A l inear SVM was trained on 1790 networks taking the unweighted and weighted mean clustering coef f icients as inputs. The “none ” class was def ined as network s for which the max imum mutual information score was below 0.6. The output classes for the test set (448 networks) are displayed in Figure 6. This can be compared to the true class labels in Figure 7. The overall performance on the test set was 83.9%. A confusion matrix of the test set performance is shown in Table 1. To conf irm these results, Figure 8 shows the mean performance, according to mutual information, when selecting the algorithm class using this classif ier. This is compared against the performance of the best weighted algorithm and the best unweighted algorithm. From these graphs it can be seen that the classif ier is able to select an appropriate class of algorithm such that it can achieve near optimum performance, constrained by the algorithms considered. Table 1: Classifier Confusion Matrix Predicted Class W eighte d Unweighted None True Class W eighted 42 Unweighted 4 None 6 3 125 5 36 18 209 From these results it can be seen that even with a simple classifier it is possible to obtain accurate predictions for the best class of community detection based on properties of the network alone. Figure 6: The predicted classif ication of the networks in the test set using a l inear SVM. F igure 7: The true classif ication of the networks in the test set. (a) µw = 0.1 (b) µw = 0.3 (d) µw = 0.7 (c) µw = 0.5 Figure 8: Mutual information scores for when algorithm class is selected by the classifier compared to the indiv idual algorithm classes. Each graph shows the performance (y-ax is) as µt (x-ax is) is v aried for dif ferent µw values. 6 Conclusion To the best of the author’s knowledge, no prev ious work has explored the problem of choosing an appropriate community detection algorithm based on the underlying structural properties. This work has presented community detection algorithms as examples of two classes of algorithm; weighted or unweighted. It is demonstrated that for different types of network and community structure, the class of algorithm has an effect on the performance. Furthermore it has been shown that it is possible to choose the algorithm class based only on the observed network parameters without prior knowledge of the community structure or assignment. The algorithm selection in this work is highly constrained both in terms of the space of possible network and community structures and classes of algorithms considered. Future work wi l l reduce these constraints by considering a wider range of input networks and a more comprehensiv e set of algorithms and classes. Acknowledgements This work was undertaken as part of an Engineering Doctorate at the Computer Science department at University Col lege London. UK Patent Pending No.: 1004376.8, March 2010 References [1] A. Lancichinetti, S. Fortunato, and J. Kertész, “Detecting the overlapping and hierarchical commun ity structure of complex networks,” New J. Phys, vol. 11, 2009, p. 033015. [2] M.E.J. Newman and M. Girv an, “F inding and evalu ating community structure in networks,” Physical Review E, vol. 69, Feb. 2004, p. 026113. [3] S. Gregory, “An Algorithm to Find Overlapping C ommunity Structure in Networks, ” Know ledge Discovery in Databases: PKDD 2007, 2007, pp. 91-102. [4] I. Derenyi, G. Pal la, and T. Vicsek, “Cl ique Pe rcolation in Random Networks, ” Physical Review Letters, vol. 94, Apr. 2005, p. 160202. [5] M. Rosv al l and C.T. Bergstrom, “Maps of random walks on complex networks reveal community structure, ” Proceedings of the National Academy of Sciences, vol. 105, Jan. 2008, pp. 1118-1123. [6] S. Fortunato, “Community detection in graphs, ” Physics Reports, vol. 486, Feb. 2010, pp. 75-174. [7] J. Moody, “Race, School Integration, and Friend ship Segregation in America,” American Journal of Sociology, vol. 107, Nov . 2001, pp. 679-716. [8] M. Girv an and M.E.J. Newman, “Community structu re in social and biological networks, ” Proceedings of the National Academy of Sciences of the United States of America, vol. 99, Jun. 2002, pp. 7821-7826. [9] S. Valverde, G. Theraulaz, J. Gautrais, V. Fourcassie, and R. Sole, “Self -organization patterns in wasp and open source communities, ” Intelligent Systems, IEEE, v ol. 21, 2006, pp. 36-40. [10] R. Guimer à and L.A. Nunes Amaral, “Functional cartography of complex metabolic networks,” Nature, v ol. 433, Feb. 2005, pp. 895-900. [11] A. Arenas, L. Danon, A. Diaz-Gui lera, P.M. Gleiser, and R. Guimera, “Community analysis in social networks, ” The European Physical Journal B-Condensed Matter and Complex Systems, vol. 38, 2004, pp. 373 –380. [12] T. Teitelbaum, P. Balenzuela, P. Cano, and J.M. Buldú, “Community structures and role detection in music networks, ” Chaos: An Interdisciplinary Journal of Nonlinear Science, vol. 18, 2008, p. 043105. [13] K. W akita and T. Tsurum i, “F inding community s tructure in mega-scale social networks, ” Proceedings of the 16th international conference on World Wide Web, Banf f , Alberta, Canada: ACM, 2007, pp. 1275-1276. [14] J. Reichardt and S. Bornholdt, “Clustering of sparse data v ia network communities—a prototype stu dy of a large online market, ” Journal of Statistical Mechanics: Theory and Experiment, v ol. 2007, 2007, pp. P06016- P06016. [15] J. Adibi, H. Chalupsky, E. Melz, and A. Valente, “The KOJAK group finder: Connecting the dots v ia integrated knowledge-based and statistical reasoning, ” PROCEEDINGS OF THE NATIONAL CONFERENCE ON ARTIFICIAL INTELLIGENCE, Menlo Park, CA; Cambridge, MA; London; AAAI Press; MIT Press; 1999, 2004, pp. 800-807. [16] J. Kubica, A. Moore, J. Schneider, and Y. Yang, “Stochastic link and group detection,” PROCEEDINGS OF THE NATIONAL CONFERENCE ON ARTIFICIAL INTELLIGENCE, Menlo Park, CA; Cambridge, MA; London; AAAI Press; MIT Press; 1999, 2002, pp. 798-806. [17] A. Galstyan and P.R. Cohen, “Identifying cover t sub-networks through iterative node classif ication, ” Proceedings of the First International Conference on Intelligence Analysis, 2005. [18] A. Lancichinetti and S. Fortunato, “Benchmarks for testing community detection algorithms on directed and weighted graphs with ov erlapping communities, ” Physical Review E, v ol. 80, 2009, p. 16118. [19] A. Lancichinetti and S. Fortunato, “Community detection algorithms: A comparative analysis, ” Physical Review E, vol. 80, 2009. [20] N. Cristianini and J. Shawe-Taylor, An introduction to support vector machines, Cambridge University Press, 2000. [21] M.E.J. Newman, “The Structure and Function of Complex Networks, ” SIAM Review, vol. 45, Jan. 2003, pp. 167-256. [22] S. Gregory, “Finding overlapping communities i n networks by label propagation, ” Arxiv preprint arXiv:0910.5516, 2009. [23] U.N. Raghavan, R. Albert, and S. Kumara, “Near l inear time algorithm to detect community structures in large-scale networks, ” Physical Review E, v ol. 76, 2007, p. 036106. [24] M.E.J. Newman, “Analysis of weighted networks, ” Physical Review E, vol. 70, Nov . 2004, p. 056131. [25] D.J. W atts and S.H. Strogatz, “Col lective dyna m ics of "small-world" networks,” Nature, vol. 393, Jun. 1998, pp. 440-442.
1301.6574
1
1301
2013-01-28T15:28:36
Self-Organizing Map and social networks: Unfolding online social popularity
[ "cs.SI", "physics.soc-ph" ]
The present study uses the Kohonen self organizing map (SOM) to represent the popularity patterns of Myspace music artists from their attributes on the platform and their position in the social network. The method is applied to cluster the profiles (the nodes of the social network) and the best friendship links (the edges). It shows that the SOM is an efficient tool to interpret the complex links between the audience and the influence of the musicians. It finally provides a robust classifier of the online social network behaviors.
cs.SI
cs
Self-Organizing Map and social networks: Unfolding online social popularity A bottom-up sociological approach Couronné Thomas, Beuscard Jean-Samuel, Chamayou Cédric SENSE Orange Labs Paris, France (Thomas.Couronne; Jeansamuel.Beuscart; Cedric.Chamayou) at orange-ftgroup.com Abstract — The present study uses the Kohonen self organizing map (SOM) to represent the popularity patterns of Myspace music artists from their attributes on the platform and their position in the social network. The method is applied to cluster the profiles (the nodes of the social network) and the best friendship links (the edges). It shows that the SOM is an efficient tool to interpret the complex links between the audience and the influence of the musicians. It finally provides a robust classifier of the online social network behaviors. Keywords: component; social networks, self organizing map, myspace I. INTRODUCTION While the primary structure of the web was centered on data (web pages), the digitization of cultural goods, the emerging of new publishing technologies and the development of social networks have produced new forms of digital practices centered on user generated content (Herring [1], Huberman [2]). The success of social platforms of photo sharing (Flickr: Prieur et al. [3]), video (Youtube: Cha et al. [4]), music (Myspace: Caverlee [5]) raises new questions about the consumption of published contents. On these platforms, each user is able to manage its own visibility; he knows how many people viewed, commented, recommended, rated, forwarded his work, and his activity is strongly oriented by these ratings (Halavais [6]; Beuscart [7]). It is important to understand the patterns of these different ratings (does a high number of friends bring a high audience?) and what kind of content receives the most attention (are artists form major labels more listened?) (Anderson [8]). Various indicators are available to estimate the popularity of a user depending on what we focus on. On one hand, we can assess popularity on the basis of the audience of the contents: number of visits of the producer's page, number of requests for the contents, number of comments. This is in fact the cumulative audience created by user's contents. On the other hand, when the popularity is focused on the user, we define it the influence or the authority, which reflects the number of people declaring the user as important for them, and measured like citation number, the social networks attributes by centrality, constrain level [9]. In this study, the word “influence ” can be understood as network authority. Audience indicators reflect the consumption of the digital goods, whereas influence describes the user ’s chara cteristics in the social network where content is shared. We demonstrate in [10] that theses two kinds of popularity are distinct and we try here to clarify the understanding of the relations between the two dimensions describing the online popularity. We can wonder if the users who have the highest audience have a specific position in the network and whether the audience elites (top charts) are the ones who have the highest influence in the network (best endogenous position). . Social network analysis is a multi-disciplinary field including sociology, psychology and computer sciences, where tools and methods are quickly sophisticating. If many researchers are working on structural questions about network patterns ([11], [12]), few deal with the links between the online and offline attributes of a user and its network properties ([13], [14]). To better understand the mixed practices that the “user generated content” platforms engender, multidimensi onal analysis methods has to be used to process data about social network position and attributes. Because practices are not pre- defined and frequently mixed it is difficult to apply supervised classification linear analysis. Therefore, our tools or contribution to this complex data analysis is performed by the use of the Kohonen Self-Organizing maps (SOM) [15]. It provides an efficient way to distinguish various forms of popularity characteristics, producing a bi-dimensional visualization of multi-dimensional data which is strongly relevant for mixed social practices interpretations. It allows to unfold the hidden correlations between variables and is robust to extreme values. Because the SOM is a learning method, it builds a classification tool which finally allows performing successive temporal analysis and classifications. Few works are dealing with social networks and Kohonen Self Organizing maps. Merelo-Guervos et al. [16] map blogs communities with SOM by a processing of a similarity matrix, which is defined by the network adjacency matrix (if A declares B as friend, then M(A,B)=1), where each feature vector is one column of the similarity matrix. They show that the SOM algorithm produces a relevant topological semantic map of the blogosphere. Our work deals with the musical artist’s popularity on MySpace social network aiming to compare the audience variables and the artist influence. MySpace is a social platform where musicians share musical content and information. For each artist, the platform displays his audience and rating scores: number of pages views –hits, number of comm ents, number of friends. The artist also declares some other users as "best friends"; these links are considered on the platform as a recommendation: choosing someone as "best friend" means, most of the time, strongly recommending his music [7]. In this paper we first present the Kohonen Self organized Maps principles. Then the data set elaboration is exposed. The first part of the analysis studies with the SOM algorithm the popularity characteristics of the profiles. The second part deals with the social network links clustering. Finally we observe how the links are distributed among the popularity clusters obtained and among the communities. II. KOHONEN SELF ORGANIZING MAP AND MULTIDIMENSIONAL CLUSTERING A self organizing map is produced by a non supervised learning algorithm. It is composed by a set of n-dimension cells, organized in an m*p bi-dimensional surface. The basic version of this algorithm defines the cells number as where k is the population to be clustered and m*p=sqrt(k). It differs from the “Growing self organizing map ” [17] in whic h the number of cells varies depending on a overlapped structure. Figure 1. Schematic Self Organising Map Each cell has a hexagonal shape (Fig. 1), therefore surrounded by six neighbors. Each individual of the population is characterized by a feature vector V of dimension n, where Vt(i) is the value of the t-th variable among the n variables characterizing the individual i. The first stage of the algorithm is the learning. The n dimensions of the m*p cells are randomly initialized. Then a subset of the population to model is randomly selected and individually processed by the SOM, moving from cell to cell until finding the “winner ” cell : the one for which the feature vector is the closest. The feature vector of the winner cell is updated, taking into account the features' values of the individual. The new values of the cells’ feature ve ctor are smoothly broadcasted to neighbors’ cells, to reduce the vectors gradient. The second stage of the algorithm is processing the global population to model. The last stage is to cluster the cells using similarity of their feature vector. The Self organizing map thus provides a set of cells in a bi- dimensional plane, where each individual is associated with only one cell. Therefore two individuals with a similar feature vector will be associated with the same cell and the ones with opposed feature vector will have a topologically opposed position on the map. As said before, this method is applied to the MySpace music population. III. DATA CONSTRUCTION We want to compare the audience and the influence characteristics in the Myspace social network. For this, we construct a crawler to collect a sample of this population. Seven initial profiles are chosen among the French MySpace music top audience, and our crawler collects the profile data via the “best friendship” links. The n umber of best friends varies between 1 and 40. Our bread first search crawl consists in navigating through the best friend ’s li nks of the parent nodes during 3 iterations. This kind of crawling produces a sample with a relevant structure (good fitting of the clustering, density, and centrality values) but underestimates the in-degree and over-estimates the out-degree ([11],[18]). The information about audience is extracted for each profile and a sample of the influence network is built on the basis of the best friendship declaration. It provides an estimation of influence for each profile. Nevertheless, this network mixes the fans and the artists, but the best friendship link between fan and artist might not be semantically equivalent as between two artists. We chose, in this current study, to remove from the network all the non-artistic profiles but we record the in-degree value of each artist in the whole network. In order to verify that the sample is not unusual, we have made several networks crawls from best friends to best friends, varying the entry numbers (from 3 to 10) and the parsing depth (from 2 to 4) (see table I). If the number of nodes and the music profiles proportion (on MySpace the account ’s profile may be defined as “me mber ” or “musician”) depends on the crawling parameters, this ratio is around 50%. Next, for each crawl, a correlation test is applied to the four quantitative variables: comments, friends, in-degree and hits. Then a Mantel test is performed on the four correlation table, showing that the coefficients are significantly similar, i.e. the variables of each sample are correlated in the same proportions (Table II). TABLE I. PROPERTIES OF FOUR NETWORK ’ S CRAWLS Network ID depth Entry A B 3 3 4 7 10 2 C 3 4 D The next table shows the Mantel Test between the crawl we study (B) and three other crawls (A,C, D). TABLE II. MANTEL TEST: CORRELATION COEFFICIENTS MANTEL Test B,A B,C B,D R 0,997 0,998 0,995 p-value (bilateral) 0,001 0,001 0,001 The data properties of the crawl ‘B ’ are summarized in the table III: TABLE III. DATASET PROPERTIES Total number of profiles Artists profiles Total Links number Links between artists number Reciprocal links rate (if A declares B as best friend, then B is highly valuable to declare A as best friend) “Major” labeled artists “Indie” labeled artists “without ” labeled artists 21153 13936 143831 83201 40.1% 3422 7069 3445 IV. POPULARITY SPACE : AUDIENCE & INFLUENCE A. Data Each musician is modeled as a node in the influence network graph, where the in-degree indexes the number of artists having declared the node as best friend (influencer) and the out-degree indexes the number of artists that a node has declared best-friends. The following variables are chosen to model the artist distribution in the audience-influence space and to construct the feature vector used for the SOM clustering: • Page views (hits): indicator for the artist’s audi ence • Number of comments • In-degree on the whole network, i.e. the cumul of fan and artists best friends links directed to the artist • the indicating In-degree on the artist network, influence weight of the artist • Page rank [19]: influence of the artist taking into account the influence of the neighbors. • Reciprocity rate: fraction of A's best friends which have declared A as best friend: cooperative behavior • Label: whether the artist record label is declared as "Major" (=3), "Indie" (=2), or "Other" (=1) The distribution law which fits the best with the networks data is generally a power-law or zipf (scale-free) [20]. When methods require normality conditions, that kind of distribution doesn’t allow immediate processing of the data. For the page view, comments and in-degrees variables, a lillifors test [21] is applied to distribution normality hypothesis. This hypothesis is rejected (p<0.01). It appears that distribution follows a power-law. Therefore a log transformation is used instead of the value itself for theses non-normally distributed variables. Thus, each node x of the graph G is characterized by a feature vector V=(v1(i),v2(i), …v7(i)) where vt(i) is the va lue of the t- th variable for the node i. B. Self Organizing map results Figure 2. Self Organizing map of the nodes depending on their attributes and popularity properties The Matlab version of the SOM algorithm used here is available on the Kohonen website. The multi-dimensional processing of the nodes by the SOM provides the Fig. 2. Two complementary structures appear: north-south and east-west. The north-south axis describes the whole notoriety on both audience and influence: north we find the less famous artists, in the south the most famous artists. The east-west axis describes the reciprocity rate: the more the artists are to the west, the more they have reciprocal links. Nevertheless, if audience and influence are partly correlated and discriminate famous from anonymous artists, the trends are not exactly similar. Indeed, the south-west area is associated with the influential elites (highest in-degree and page-rank) and the south-east area is associated with the popular artists in terms of audience (highest page views and comments). If, logically, the audience elites are not without influence and influential elites are not without audience, the top artists of the audience and the influence do not overlap. We can observe that the two kinds of in-degree distribution (whole network and artists sub-graph) are similar. It means that the distribution of best friendship between artists and between fan and artists is the same: the influential hierarchy appears to follow the same rules even if the links do not have the same semantic. The reciprocity distribution shows that the more the artists have a sociability dynamic (non null in-degree), the more the reciprocity is strong. But this reciprocity appears stronger for the middle and low level of influence than high influence ones: maybe because an influential artist can’t have more than 40 best friends (and therefore can not cite everybody) or maybe because very influential artists are not linking back to people who link to them. Finally we observe that the south-east area (audience elites) is associated with a strong presence of the « Major » labels. This label is also found in the one-third north part of the map, where these artists might have a social authority that the south east one majors' artists don’t have. A-Topological Distance U matrix B-Cluster colored U matrix C-Gender colored U matrix Figure 3. U matrix depending on distance, musical gender and clusters A simple k-means clustering is performed on the cells distance matrix (Fig. 3-A). The expectation maximization algorithm is then employed to choose the best number of clusters. 5 clusters are defined here (Fig. 3-B): • 1: Cyan: artists with very high audience, low influence and weak reciprocity links rate. They are Major labels' artists, with a strong offline marketing strategy that brings them a strong audience, but no intense MySpace strategy, therefore displaying relatively weak influence rates. 2: Dark blue: influential artists have a whole notoriety (audience + influence) lower than the superstars, but have an efficient innovative online marketing strategy that brings them an authoritative position on MySpace. They often correspond to trendy, avant-garde music. 3: Green are superstars, the most notorious artists, both influential and popular. They are the MySpace elites, having a high level online marketing strategy or a strong popularity in traditional Medias. 4: Brown are anonymous artist with a small audience and no active socializing practices. 5: Orange are socially dynamic artists with low audience. They are non professional artists swarms well inserted in the local music stages. • • • • To know who belongs to the MySpace ’s elite, we focu s on the artists belonging to the upper percentile of the page hits (audience) and the In-degree (influence). Figure 4. Label distribution for the global sample, the audience elits and the influence elits Fig. 4 shows that while the 1% hit ’s elite is mainl y associated with ‘majors” artist, the most influential artists are a mix between independent and majors. If the artists labeled as “majors” are the undisputed stars of the audience o n MySpace (they constitute 73% of the upper hit percentile, against 14% in the sample), the artists labeled as independent constitute an important part of the most influential artists (55% of the upper influential percentile, against 54% of the sample). Fig. 3-C shows the SOM map where the cells color depends on the dominant music gender of the artists belonging to the cell. The map represents the proximity between the various music genres and the popularity, showing whether some musical genres are especially associated with some strong audience values or weak influence. The observation of the map does not confirm the hypothesis that some genres are associated with specific notoriety values. A complementary information which doesn’t appear on the map and might help to read is that among the 10 dominant genders, 4 are a default musical declaration (alternative, null, other and indie) even though the artists can chose between 110 different genre. V. LINKS MODEL In order to complete our understanding of the nature of the influence links, we study the characteristics of the links. Each link can be described by a feature vector, where each value is a gradient depending on the link emitter and receiver properties. The SOM processes the gradients, and shows if the anonymous artists declare as best friends elite ’ artists (str ong or weak gradient). Let A be a variable describing the nodes, then gradient g is defined by: g= (A(receiver)-A(emitter) )/(A(receiver)+A(emitter)) If the two nodes have the same value then g=0; if the emitter ’s value is highest, g tends to -1, otherwis e 1. The following variables are selected to build the feature vector for each link: • Hits gradient • Comments gradient • Influence (In-degree) gradient • Common predecessor in the graph (artists declaring commonly A and B as best friend) • Common successors. (artists declared as best friend commonly to A and B) • Whether the musical gender is similar (1) or differs (0) • Whether the link is reciprocal or not (A->B and B<-A), (value=1 if reciprocal, 0 otherwise) Figure 5. Self organizing map of the best friendship links The processing of the influential links with a SOM shows (Fig. 5) that the main variable discriminating the links is reciprocity. Thus, the cells belonging to the north-west part of the map has non reciprocal links. This area is also associated with links between artists declaring different music genres: such kind of mixed genres links tend to be unidirectional. The north-east area is associated with links having a strong positive popularity gradient (audience and influence): the emitter of the influence link is less famous than the receiver; whereas the south-west area is associated with links having a strong negative gradient (the emitter is more famous than the receiver). This south-west area is also correlated with reciprocal links, while the north area has a weak reciprocity. These results show that the links with negative gradient are also reciprocal: the elite do not connect without reciprocity to a less-famous artist. Finally, in the extreme south-west cells are the links with a strong similar neighborhood: they have a highest number of common predecessor and successor in the network. Thus, both variables are well correlated: when A and B are recommended by a common artist, then the probability that A and B recommend a common artist is strong. The second comment is that this co-influence area is associated with reciprocal links, medium level popularity and low to medium genre differences. To clarify the interpretation we plot again the Self Organizing map with the clusters ids. Figure 6. A: Distance U matrix; B:clusters Figure 8. Clusters labels Let remember with help of the Fig. 7 and Fig. 8 that in the clusters 1 and 4 are artists having a part of audience and low influence. The 5th cluster gathers artists having a low influence and little audience. The cluster 2 is associated with influential artists, and the cluster 3 with globally popular artists. We estimate the link frequency between clusters (best friendship declaration between artists who don’t be long to the same cluster). Let M be the transition matrix: M(i,j) is the number of links declared from artists of the i-th cluster to artists of the j-th cluster. The matrix M is normalized per line, i.e. defines the probability distribution P(j/i) of the links emitted by the artist from the i-th cluster to the other j clusters where j=[1-5]. The distance matrix (Fig. 6-A) shows the partition of the links. The links from the north-west part are non reciprocal; it links artists with a different musical genre and few common neighbors, and have a positive popularity gradient: they describe a cluster of relational links such as master - student or fan - star. The links of the south-west part are reciprocal, with a common neighborhood; the popularity gradient is positive or negative, but with medium to low values: theses links can be understood as recommendation declarations. After having observed independently the nodes and the edges properties, we compare the edges distribution among the nodes' clusters. VI. NODES' POPULARITY CLUSTERS AND INFLUENCE LINKS The popularity clustering of artists raises questions about the influence distribution among theses clusters. More especially we can wonder in which proportion the influence links are distributed intra- and inter-clusters and, about the inter-clusters links, which clusters are inter-linked. A principal component analysis recalls the relative properties of each one of the five nodes clusters on the Fig. 7. Figure 9. Density matrix The density matrix (Fig. 9) shows first of all that the most influential clusters are clusters 2 and 3 (highest linking probability). The cluster 3 possesses the most famous artists and the cluster 2 the artists having a strong social activity, with reciprocal links and community dynamics. The comparison of the emitter clusters shows that the clusters 2 and 5 have the same links destination trend, which differs to 4 and 1. The cluster 2 and 5 distribute their links to the clusters 2 and 3, with a small favor to the 2. The trend is inversed for the artists belonging to cluster 1 and 4, who declare as best friends mainly the most popular artists (cluster 3). Finally, the most popular artists (3) declare each others as best friend, but occasionally links to artists from cluster 2. These results confirm the following hypothesis: Figure 7. Principal components analysis of nodes clusters (red: clusters IDs, nouns: quantitative variales • There is a social class of influential artists who, benefiting of the community dynamics, receives links from the whole population, elite included. • The artists with links (small in degree reflecting a social activity) are at least equally likely to connect to influential artists as to notorious ones. • The artists with a low influence and non reciprocal links tend to declare very famous artists as influence (and the elite non-reciprocal behavior explains the lowest level of their incoming links). • The most popular artists tend to declare each other as influence. VII. SOCIAL NETWORK STRUCTURE ANALYSIS Our data consists in a set of musician profiles (nodes) and best friendship links (edges). It is therefore relevant to draw the network and observe the macrostructure of the collected sample. The nodes’ color is defined by the musical genre the artist belongs to; the nodes ’ size is defined by th e artists’ audience. Figure 10. MySpace social network sample. The left one draws a clique of jazz musician; the right one shows the core of the influence network, composed by audience elites belonging to electro pop music, and surrounded by electro and indie artists It appears (as shown on Fig.10) that some cliques (communities) are well identified and are composed by artists playing the same musical genre e.g. jazz or black music. These communities have a strong density and are linked to the main component by artists whose musical work is mixed or not well categorized like indie music. If the main component is composed by a mixture of musical genres, we observe that the audience ’ elite (biggest nodes) is well interlinked . Some commercial labels seem to have an efficient linking strategy (Ed Banger label): they are strongly central in the network, each artists citing each other. Moreover, they are well cited by artists having another musical genre. Because some artists of such community have a strong audience, people visiting these artists are highly likely to visit their friends: the audience is redirected to the other artists of the label. In a second analysis, the network is processed with the “Linlog” algorithm [22]: after a spatial layout pro cessing, each node obtains two dimensional spatial coordinates. Then a partitioning is applied on theses coordinates: artists having the same neighbors (predecessors or successors) are likely to belong in the same clique (same partition). Each link is then either “intra clique” (both extre mities in the same clique) or “inter clique”. We wonder if there is a relation between the kind of notoriety the artists have (as modeled by the clustering of the SOM) and the ability to link to artist who are not in the neighborhood. Therefore, we compute for each SOM cluster the fraction of links emitted between artists who do not belong to the same spatial community. TABLE IV. INTER CLIQUE LINKS FRACTION PER CLUSTER, DECREASING ORDER popularity cluster 1 4 3 2 5 link 'inter', fraction 0,3276 0,1869 0,2022 0,2291 0,2867 The popularity clusters 1 and 4 are those who have the highest inter-community rate, as opposed to clusters 2 and 5. It means that artists with audience and few or no influence are more able to recommend artists from various cliques and not exclusively their neighbors, than artists being in a reciprocal linking dynamic. It confirms the hypothesis that the artists of the second and fifth popularity cluster, who are defined as having a socialization activity, have a highest intra clique linkage. VIII. CONCLUSION The main idea of this work is to study the popularity of MySpace artists. More especially we want to detect whether or not the audience elites and the influential ones overlap. Therefore we introduce the Kohonen Self Organized Map to analyze the relations between audience (variables exogenous to the social network) reflecting the position in the music industry), and the influence (endogenous variable) revealing the macroscopic patterns of the online social structure. A SOM is established to cluster the nodes depending on their popularity variables. It confirms the hypothesis that audience and influence are two distinct dimensions. Then a SOM is performed on the links, which are characterized by the similarity of the nodes they link. It demonstrates that audience is not correlated to a reciprocal recommendation process. We then observe the inter-linkage between the popularity clusters, showing that elites tend to recommend each other. Finally, we process a network partitioning, to obtain best friendship cliques, and we show that the fraction of links between people of one clique is not the same depending on the popularity cluster of the artist who creates the recommendation link. The SOM method appears robust to extreme values and stable: even if the initialization process is randomized, the obtained SOM is constant. One of the main interests of this method is its visualization mode, which seems strongly relevant to explore the non linear, hybrid, or mixed social practices. Moreover, the SOM learning properties provides an easy way to classify immediately new individuals, in the aim to observe the networks' dynamics among time. If this study is only a contribution to the description of practices trends on MySpace, it contributes to a better understanding of the online popularity and suggests an efficient method to analyze the social network properties and the popularity characteristics. The next step might be to establish topological maps of the social communities with the growing SOM version, to compare them to the diffusion of the social practices in the network. IX. REFERENCES [1] Herring, S.C., Kouper, I., Paolillo, J.C., Scheidt, L.A, Tyworth, M., Welsch., P., Wright, E., Yu, N. 2005. "Conversations in the Blogosphere: An Analysis "From the Bottom Up", Proceeding of the Thirty-Eighth Hawai International Conference on System Sciences, Los Alamitos, IEEE Press. [2] Huberman, B.A., Romero, D.M., Wu, F. 2008. "Crowdsourcing, Attention and Productivity", arXiv:0809.3030v1. [3] Prieur, C., Cardon, D., Beuscart, J.S., Pissard, N., Pons, P. 2008. "The Strenght of Weak Cooperation: A Case Study of Flickr", arXiv:0802.2317. [4] Cha, M., Harwoon, K., Rodriguez, P., Ahn, Y.Y., Moon, S. 2007. "I Tube, You Tube, Everybody Tubes: Analysing the World's Largest User Generated Content Video System", presented at the IMC'07, San Diego, California [5] Caverlee, J. & Webb, S. 2008. "A Large-Scale Study of MySpace: Observations and Implications for Online Social Networks", presented at the ICWSM 2008 Conference. [6] Halavais, A. (2008) Do Dugg Diggers Digg Diligently, procedings aoir 2008 [7] Beuscart, J.S. 2008. "Online interactions, virtual reputation and artistic carreer. The uses of MySpace by self-produced musicians", Réseaux, n °152. [8] Anderson, C. 2006. The Long Tail: How the Future of Business is Selling Less of More, New York, Hyperion BooksBae, S.J., Gloor, P., Schnorf, S.: Detection of Power User Patterns among High School Students in a Mobile Communication Network. In: Applications in Social Network Analysis 2005 (University of Zurich, Switzerland 2005 [9] Kleinberg, J. (1999). "Hubs, authorities, and communities" in ACM Computing Surveys 31(4), December 1999. [10] Beuscart, Couronné (2009) The distribution of online reputation. In ICWSM 09 proceedings– in press [11] Mislove, A., Marcon, M., Gummadi, K., Druschel, P, Bhattacharjee, B. (2007) Measurement and Analysis of Online Social Networks IMC ’07, October 24-26, 2007, San Diego, California, USA [12] Bae, S.J., Gloor, P., Schnorf, S.: Detection of Power User Patterns among High School Students in a Mobile Communication Network. In: Applications in Social Network Analysis 2005 (University of Zurich, Switzerland 2005 [13] Maia, M., Almeida, J.,Almeida V. (2008) SocialNets’ 08, April 1, 2008 , Glasgow, Scotland, UK [14] Parks, M. (2008) Characterizing the Communicative Affordances of MySpace: A Place for Friends or a Friendless Place. presented at the annual conference of the International Communication Association, Montreal, May, 2008 / Also submitted to the Journal of Communication [15] Kohonen, T. The self-organizing map. Procs IEEE, 78:1464 ff., 1990 [16] Merelo-Guervos J.J., Prieto B., Rateb F. (2003) Mapping weblog communities (http://arxiv.org/abs/cs.NE/0312047) [17] Alahakoon, D., Halgamuge, S. K. and Sirinivasan, B. (1998) A Self Growing Cluster Development Approach to Data Mining in Proceedings of IEEE International Conference on Systems, Man and Cybernetics, San Diego, USA, pp 2901-2906 [18] Kumar, R., Novak, J., Tomkins, A. (2006), Structure and Evolution of Online Social Networks, KDD ’06, August 20 –23, 2006, Philadelphia [19] Brin, S. and Page, L. (1998) The Anatomy of a Large-Scale Hypertextual Web Search Engine. In: Seventh International World- Wide Web Conference (WWW 1998), April 14-18, 1998, Brisbane, Australia. [20] Adamic, L. Huberman, B. (2002). Zipf’s law and the Glottometrics, Vol. 3 (2002), pp. 143-150 [21] Lilliefors, H. (June 1967), "On the Kolmogorov–Smir nov test for normality with mean and variance unknown", Journal of the American Statistical Association, Vol. 62. pp. 399–402 [22] Noack.A. (2007) Energy Models for Graph Clustering. Journal of Graph Algorithms and Applications 11(2):453-480, 2007. Internet,
1312.2094
1
1312
2013-12-07T13:32:39
Parallelization in Extracting Fresh Information from Online Social Network
[ "cs.SI" ]
Online Social Network (OSN) is one of the most hottest services in the past years. It preserves the life of users and provides great potential for journalists, sociologists and business analysts. Crawling data from social network is a basic step for social network information analysis and processing. As the network becomes huge and information on the network updates faster than web pages, crawling is more difficult because of the limitations of band-width, politeness etiquette and computation power. To extract fresh information from social network efficiently and effectively, this paper presents a novel crawling method and discusses parallelization architecture of social network. To discover the feature of social network, we gather data from real social network, analyze them and build a model to describe the discipline of users' behavior. With the modeled behavior, we propose methods to predict users' behavior. According to the prediction, we schedule our crawler more reasonably and extract more fresh information with parallelization technologies. Experimental results demonstrate that our strategies could obtain information from OSN efficiently and effectively.
cs.SI
cs
Parallelization in Extracting Fresh Information from Online Social Network Rui Guo, Hongzhi Wang, Mengwen Chen, Jianzhong Li, Hong Gao Harbin Institute of Technology Abstract Online Social Network (OSN) is one of the most hottest services in the past years. It preserves the life of users and provides great potential for journalists, sociologists and business analysts. Crawling data from social network is a basic step for social network information analysis and processing. As the net- work becomes huge and information on the network updates faster than web pages, crawling is more difficult because of the limitations of band-width, po- liteness etiquette and computation power. To extract fresh information from social network efficiently and effectively, this paper presents a novel crawling method and discusses parallelization architecture of social network. To dis- cover the feature of social network, we gather data from real social network, analyze them and build a model to describe the discipline of users' behavior. With the modeled behavior, we propose methods to predict users' behavior. According to the prediction, we schedule our crawler more reasonably and ex- tract more fresh information with parallelization technologies. Experimental results demonstrate that our strategies could obtain information from OSN efficiently and effectively. Keywords: Online Social Network, Crawler, Freshness 1. Introduction 1.1. Motivation Social Network Service is one of the hottest services in the last few years. It has a tremendous group of users. For instance, Facebook has 874 million active users [1] and Twitter reaches 500 million users. It is estimated that at least 2.3 billion tweets have been published on Twitter during a 7-month pe- Preprint submitted to Knowledge-Based System Journal June 22, 2021 riod, more than 300 million tweets per month [2]. And The Yahoo! Firehouse has reached 750K ratings per day, 150K comments per day [3]. There are a few social media datasets such as Spinn3r [4]. About 30 million articles (50GB of data), including 20,000 news sources and millions of blogs were added to Spinne3r per day [2]. As people access OSN frequently, advertisement could be broadcast according to users' behavior. [5] studies various Super Bowl ads by applying data mining techniques through Twitter messages. Using Twitter, [6] detects earthquakes and [7] studies influenza spread. For crawling, one of the most important factors is the freshness. Denev, Mazeika, Spaniol and Weikum [8] designed a web crawling framework named SHARC. It pays more attention to the relationship between freshness and time period. Moreover, Olston and Pandey proposed a crawling strategy optimized for freshness [9], it concerns more about the current time point. Even though OSN crawling is related to web crawling, crawling OSN for fresh information is different from web crawling in following points and brings new technical challenges. 1. New messages are published more frequently. Everyone can conve- niently register, post, comment and reproduce messages at twitter.com while a server and special skill is required to maintain a website. As a result, the hottest topic may change in few hours on the OSN. With this feature, freshness metrics for web crawlers could not be applied on OSN crawlers perfectly. 2. The messages on OSN are shorter than web pages. The former are often made up by a few sentences (e.g. Twitter limits its messages to 140 characters) while the latter often contain titles and long contents. 3. The OSN is closely related to users' daily life. Ordinary people post messages in the day and not at night. Hence we must consider people's work and rest time when crawling for OSN messages. As a comparison, this feature is not considered in web crawling. 4. OSN network is more complex. The relationships between close users are shown explicitly. We can trace the friend relationship and forwarded message easier than on the web. The web pages are usually open to everyone while some OSN mes-sages are only available for friends, such as Facebook messages. With these features, new techniques for crawling fresh OSN information are in demand. What's more, in a real crawler system, many machines are running the crawler program at the same time, leading to a series of problem 2 such as task schedule and workload balance. So it is necessary to design a parallelization crawler architecture. With the consideration that the goal of crawling OSN information is to gather new information, this paper aims to crawl as more new messages as possible with the limited resources. 1.2. Contributions For crawling, the limitations on resources include bandwidth, computa- tion power and politeness etiquette. For instance, for twitter.com, we may be permitted to get at most 200 tweets with a Twitter API call. The restriction on the method call is 350 calls per hour for one authorized developer account [10]. Actually, the API restriction is the bottleneck of most OSN crawlers. To leverage the limited resources and freshness requirements of the crawler, we classify the users according to their behaviors and model their behavior of updating posts respectively. With these models, the time of post updating for different users is predicted and the crawler could access the posts of users only when corresponding is updated. As a result, the latest information is collected with limited resources. Combing the steps discussed above, we propose Crawl based on User Visiting Model (CUVIM in brief) based on the observations and classifica- tions of users' behaviors. In this paper, we focus on the messages in OSN. Considering the relationship updating between users as a special type of mes- sage, the relationship of updating information could also be crawled with the techniques in this paper. According to different behaviors on updating the posts, we classify OSN users into 4 kinds: the inactive account, frequently changing account, reason- able constant ac-count, and authority account. This is the first contribution of this paper. We design different updating time predication model and accordingly develop efficient crawling strategies. This is the second contribution of this paper. Concretely, for the inactive accounts and frequently changing accounts which change not very frequently, the changes can be described by the Poisson process and the changing rate can be predicted by statistics methods. Thus we build the Pois-son model and take web crawling strategy to crawl OSN data. From reasonable constant accounts and authority accounts who post mes- sages frequently, we observe that the frequency of new messages is related 3 to users' daily life. According to this observation, we can crawl many fresh and useful messages in the day while almost no new messages at night. And we build the Hash model to visit those active users to crawl the information efficiently. As the third contribution, extensive experiments are performed to verify the effectiveness and efficiency of the techniques in this paper. We crawled the last 2,000 messages of 88,799 randomly selected users. The result shows that 80,616,076 messages are collected. From experimental results, the Poisson process model collects 12.14% more messages than a Round-and-Robin (RR) style method. The Hash model collects about 50% more messages than the RR style method. The parallelization method limits the workload difference of the Poisson process model to less than 13.27% of a random method. We also tested our parallelization crawler architectures. The results show that the speed up of the architectures are linear while the workload difference between the machines is almost ignorable. This paper is organized as follows. Section 2 reviews related work at crawler field; Section 3 introduces our work and discovery from the data; Section 4 introduces our crawl altimeters; Section 5 introduces the paral- lelization technology in the crawler system; Section 6 shows the experimen- tal results; Section 7 draws the conclusions and proposes further research problems. 2. Related Work Only a few methods are proposed to crawl OSN data. [5] describes a Twitter Crawler developed by Java. They pay more attention to the imple- mentation detail of the crawler and the data analysis. Instead, we focus on the crawling method and develop algorithms to gather more information of the specific OSN users. TwitterEcho is an open source Twitter crawler developed by Boanjak et al. [11]. It applied a centralized distributed architecture. Cloud computing is also used for OSN crawler [12]. Noordihuis et al. collect Twitter data and rank Twitter users through the PageRank algorithm. Another attempt is to crawl parallel. Duen et al. implemented a parallel eBay crawler in Java and visited 11,716,588 users in 23 days [13]. The three methods aim to get more calculating resource, while we focus on a more reasonable crawling sequence with the given resource. 4 Whitelist accounts were once available on Twitter. Kwak et al. crawled the entire Twitter site successfully, including 41.7 million user profiles and 106 million tweets by Twitter API [14]. However, whitelist accounts are no longer available now. It is the same for [12]. As the API has rate-limiting now, we propose algorithms to improve the crawl efficiency. Another related work to OSN message collector is web crawlers. Generally the page changing follows the Poisson process model. The Poisson process model assumes that the changing rate λi in every same time unit ∆ is the same. And the changes are modeled as following formula. P [changes in ∆ is k] = e−λi∆(∆λi)k k! This equation can predict the possible changes of web pages and can be applied on only the inactive OSN users, since they usually change con- stantly. However, when considering the active OSN users who post messages frequently, the change rate is not equal all the time. The discipline of OSN messages follows the users' daily life. A user may post many messages in the day and much less at night, so the changing rate is not same for the day and night. Many web crawlers are proposed. Reprehensive measures for web crawl- ing are sharpness [8] and freshness [9]. The strategies define sharpness or freshness to the crawling, and schedule crawling to achieve those targets. Differently, we choose the total number of new OSN messages as our target, and schedule according to the OSN users' behavior. There are other matured web crawling strategies. J. Cho, H. Garcia- Molina and L. Page improve the crawling efficiency through URL ordering [15]. They define several importance metrics including ordering schemes and performance evaluation measures to obtain more important URL first. J. Cho, H. Garcia-Molina also pro-poses a strategy for estimating the change frequency of pages to make the web crawl-er work better [16] by identifying scenarios and then develop frequency estimators. C. Castillo, M. Marin, A. Rodriguez and R. Baeza-Yates combine the breadth-first ordering with the largest sites first to crawl pages fast and simply [17]. J. Cho and U. Schonfeld make PageRank coverage guarantee high personalized to improve the crawler [18]. 5 3. OSN Data Analysis And Classification At first, to design the proper crawler for OSN, we discuss the features of OSN data and the classification of OSN users by their behavior in this section. Considering the four features of the OSN in Section 1, we propose novel methods. At first, we define audience and channel as following in OSN relationships to study the OSN, where both A and B are users. Definition 1. (audience) Audience is a one way relationship on OSN. A is B's audience, that means, A can check B's OSN messages. Definition 2. (channel) Channel is a one way OSN relationship on OSN. A is B's channel, that means, A's messages will be checked by B. To study the behavior of OSN users of messages updating, we crawl and study OSN messages. For effective crawling, we choose several top OSN users from the influence ranking list in Sina weibo (http://weibo.com), which is a famous OSN with millions of users. They are added to the crawling list as the seeds and some of their channels are randomly selected. The channels behave more active than the audiences, thus we can avoid invalid accounts in the list. The channels are added to the crawling list. Then they are treated as the new seeds and their channels are accessed. We can end the iterations when we get enough users in the crawling list. traversed, the crawling list contains(cid:80) n With a seeds, k channels are chosen and n-hop channels for each seed are akn = a(kn+1− 1)/(k− 1) users. From this formula, the smaller n is, the more representative the users in the list are: at the beginning the seed users are famous, and later more and more ordinary people are added into the list. Since without any information, it is impossible to predict the frequency of posting, initially, we have crawled the data for all users in a Round-and-Robin style. i = 0 We crawled 10,000 users' data for two months, and got 1,853,085 mes- sages in total. According to the experimental results, we have following observations. 1. Users are quite different in posting frequency. The users in the crawling list have at least one audience. It means that those accounts are valid and are or were once active. However, during the experiment period, about 1/2 users post less than one message per day. And 1/5 users post more than 10 messages per day. This observation means that the crawl frequency for different users should be different. 6 Figure 1: The Updating Ratio of an Inactive Account 2. The frequency of new messages may change with time. An extreme user post 18 messages in the first day but did not post anything in the following three days. 3. The frequency of posting new messages is related to the users' daily life. Experimental result shows that an actress posts about half messages in the late night while a manager posts most messages in the afternoon. 4. Some accounts are maintained by professional clerks or robots, such as a newspaper's official account. Those accounts have more audiences, change more frequently and have more influence than the personal users. With above observations, we classify all users into 4 types by their be- havior. To illustrate the features of these four kinds of users, we show the experimental results of four user's belonging to each type in Figure 1 to 4. It shows the total number of new messages in each 15 minutes of a day. The horizontal axis means time from 00:00 to 24:00 in a day, and the longitudinal axis means the total number of new messages post with 15 minutes as the unit. In Figure 1, 3 and 4, the line in the figure means the number of all messages in the 2 months. In Figure 2, each line means a day. 1. Inactive account. The users in this type post nothing in a long period or have little channels and audiences. From Figure 1, it can be observed that the figure of inactive account has at most a few points. It means that the user has hardly post any messages in a day, but may a few messages in a few weeks. When observing for a long period, those users behave as web pages. It means that an inactive user may post three messages a month while a page may change three times this month. The number of possible changes between each equal time unity ∆ when ∆ is large enough. Thus we can describe the behavior of this type by Poisson Process. 7 Figure 2: The Updating Ratio of an Instable Changing Account 2. Instable changing account. Such type of users' behavior is instable and cannot be predicted. Users in this class are often very active at a short period and remain silence later. For example, the one who post 18 messages and did not post anything in later 3 days. It is hard to design an effective crawling strategy for those people. Figure 2 shows the behavior of a instable changing account. The user posted 2 messages on Monday, 13 messages on Tuesday and nothing in the later three days. It is the most irregular one among all figures. It may be illustrated that the user has a sudden trip and cannot connect to the OSN, or the work those days are busy so he pays little attention to OSN. And those users may become reasonable constant users when he returns or finishes the work. There is no effective strategy to crawl this kind of users, for we cannot predict their behavior, thus we cannot schedule the crawler well. We treat those users as the inactive accounts to save crawling resource, and put them into the reasonable constant users once. We found that they post many messages every day in the recent week. 3. Reasonable constant user. Most valid accounts belong to this type. For example, the users with work far from computer or mobile phone have to post messages after work and the users working with computer will post in work day in the office. The frequency of the new messages is obviously influenced by the users' daily life, and the new messages often occur frequently in the afternoon and at night when the user takes a rest. Hence we can predict their behavior by historic data. Figure 3 shows the behavior of a reasonable constant user. Such users love the OSN very much and post messages very regularly. This kind of figures often has two peaks, the afternoon and the night. The curve in the 8 Figure 3: The Updating Ratio of an Reasonable Constant Account Figure 4: The Updating Ratio of an Authority Account left of the peak grows up and the one after the peak goes down. 4. Authority account. Such accounts are maintained by several clerks or just robots. The content of those accounts is carefully updated far more frequent than ordinary people and is reviewed by more users. For example, the New York Time updates news quickly on Twitter and has a large group of audience. Figure 4 shows the behavior of an authority account. The kind of figures is higher than the usual users' and has more peaks than the reasonable constant use. From the result, there are one peak for each hour, and the peaks are almost the same high. The reason is that clerks or robots may be asked to post messages once an hour. 4. User Behavior Model And Crawl Strategy According to the behavior of the users, we build two models for effective crawling, the Poisson process model and Hash model. 9 The Poisson process model is built for inactive users, who behave similar to web pages, and the effective web crawling strategy such as SHARC [8], trade-offs [19] and sampling [20] can be applied to those users. The Hash model records the principle of very active users' behavior. For those users, we consider the frequency change in a day, and the change rate λi is not same all the day long. Hence the Poisson process cannot describe it. One effective way is to record the historic data change rate to predict the parameters for crawling. 4.1. Poisson Process Model According to the observation of inactive users, we build a Poisson process model for their posting frequency, since those users behave like the updating of web pages, including changing constantly in a comparative long period (e.g. a month). We assume that the change rate λi can be estimated according to historic data, the number of audiences and channels, just as estimating change rate of pages by types, directory depths, and URL names. However, the web crawling metrics require to be modified to fit OSN. The SHARC [8] define the blur for web pages, it describes the difference between the new and old pages of the same URL. Yet this could not be applied to OSN. The blur means the possibility that a page changes, but for the OSN, the question is the possible number of new messages, rather than whether a new message is post or not. Thus the blur cannot describes the messages. To describe the freshness of messages in OSN, we define the potentiality for the users and the crawling target is to minimize the total potentiality. We define the potentiality for OSN as follows. Definition 3. (Potentiality) Let ui be a OSN user crawled at time ti, The potentiality of the user is the expected number of new messages between ti and query time t, averaged through observation interval [0, n∆]: (cid:90) n∆ 0 P (ui, ti, n, ∆) = 1 n∆ λit − tidt = λiω(ti, n, ∆) n∆ , where ω(ti, n, ∆) = t2 i − tin∆ + (n∆)2 2 is the crawling penalty. 10 Let U = (u0, ..., un) be OSN users crawled at the corresponding times T = (t0, ..., tn). The blur of the crawling is the sum of the potentiality of the individual users is defined as, P (U, T, n, ∆) = 1 n∆ λiω(ti, n, ∆) n(cid:88) i=0 . (ti, n, ∆) denotes the crawling penalty. It depends on the crawling time ti and the period of the crawling interval n∆, but not on the user. And we obtain Theorem 1. Theorem 1. (Properties of The Schedule Penalty) Double crawling delay will lead to fourfold crawling penalty and double potentiality: ω(i∆, n, ∆) = ∆2ω(i, n, 1) P (U, T, n, ∆) = ∆P (U, T, n, 1) For the interests of space, we omit the proof of Theorem 1. For instance, the change rate for user u0 to u5 is λ0=0, λ1=1, λ2=2, λ3=3, λ4=4 and λ5=0, then we should crawl those users in the order u0, u2, u4, u5, u3, u1, thus we get the potentiality minimum. Algorithm 1 Crawl Schedule with Poisson Model input: sorted users (u0, ..., un−1) output: crawl schedule (uD 0 , ..., uD n−1) 1 for i ← 0 to n 2 3 4 do if i is even then uD else uD i = ui/2 i = un−(i−1)/2 Algorithm 1 depicts the Process model algorithm for inactive users in OSN. All the users are known advance. We can sort and scan all the users only once to schedule the crawler. The time and space complexity are both O(n). Thus we scan the user list only once. 11 4.2. Hash Model According to the observation of reasonable constant users and authority accounts, we build the Hash model. The changing rate λi for those users is stable from the observations for a long time (e.g. a week or longer). However, the new OSN messages are posted so frequently that they need to be crawled very frequently. If we visit these users according to the averaged λi of the day, we will waste much resource. For example, we visit the user in the Figure 3 according to the Poisson process model. In the Poisson process, the number of possible changes in each time unit is the same, so the time span between each extraction should be the same. If we start crawling at 00:00 and crawl twice a day, it may be 00:00 and 12:00. However, crawling at 03:00 and 19:00 seems the best strategy. Thus the Poisson process model does not fit those active users perfectly. The number of active users' new messages changes frequently and is com- parative randomly. Hence it is hard to find a precise and suitable model. On the other hand, the number of such kind of users is not large enough and a statistics model such as Gaussian model cannot be constructed according to the behaviors. One effective way to predict the users' behavior is to record the historic data. With such considerations, we define Hash model to obtain the messages of the active users better, including the reasonable constant users and authority accounts. This model is built for the users who need to be crawled frequently, at least twice or more a day. This model uses a hash table to record the number of new messages in a short recent period and the earlier data has less weight. According to this historic data, we can calculate the possible number of new messages that are post in a given time span, so we can schedule the crawler better. For example, we maintain an array of 24 bytes (a1, ..., a24) to record the number of new messages posted by the same user in each hour. ai values 0 at the beginning and the new value (cid:48) i = ai ∗ 0.5 + n ∗ 0.5 a where the parameter n is the number of messages posted by the user at the ith hour of the day. The weight for k days before is 0.5k. As a result, the parameter for today is 0.5 and 0.25 for yesterday. If a user does not post any messages for a few days, the values of the hash table decrease very fast. To avoid such phenomenon, the longest crawling 12 span threshold s is required, that means, we will crawl the user at least once s hours or days. Although the hash-based method can be used for active user crawling, it is not suitable for some special cases. For some special dates, such as the weekend, people behave differently from workday. The experiment results of 100 users in 2 weeks show that 1496 messages were post on Tuesday while only 874 messages on Sunday. Thus we could predict users' behavior by the last weekend data according to this feature. Similar predications can be applied for the public holiday, such as the national day. It is required to consider about the near and similar holiday data, or even the last year's vocation data with the hash model. Algorithm 2 depicts the Hash model for one user. Algorithm 2 Crawl Schedule with Poisson Model input: a1, ..., ak, n1, ..., nk output: crawl time list L do ai = ai ∗ 0.5 + ni ∗ 0.5 1 lastCrawlT ime = 0, sum0 = 0 − remainingM essage 2 for i ← 1 to k 3 4 sum1 = a1 5 for i ← 2 to k 6 7 for i ← 1 to k 8 9 10 11 remainingM essage = sumk − sumlastCrawlT ime do sumi = sumi−1 + ai do if (sumi − sumlastCrawlT ime > c) or (i − lastCrawlT ime > s) L.add(i) lastCrawlT ime = i The length of the hash table is k , we crawl c messages each time and the user post ni messages yesterday at the time span i, remainingM essage is the number of messages that are not crawled the day before, the sumi means the sum from a1 to ai and sum0 is the number of minus remainingM essage, thus number of the remaining messages that are not crawled yesterday will be count, and the longest crawling span threshold is s. We input a1,...,ak, n1,...,nk and it will output the crawl time list L. First, we update the lastCrawlT ime and sum0, and calculate the values of the hash table and the value of sum1...sumn. Second, we scan the sums. If there are enough messages to crawl (sumi − sumlastCrawltime > c) or the 13 crawl time span exceed the threshold (i− lastCrawltime > s ), then we add the time point i to the crawl time list L and update the lastCrawltime. The time and space complexity is O(n). 5. Parallelization As the information updates very fast on OSN, effective applications for OSN data require to collect messages on OSN at a high speed to keep the freshness of crawled data. However, two factors prevent the high speed crawl- ing. One is the API quota for data accessing is seriously limited by the OSN platform (350 calls per hours on Twitter, and 150 calls on Sina Weibo). An- other is the computation required by information extraction from the crawled information and the size of social network is very large. It is natural to design parallel algorithms to obtain fresh information from OSN. With a number of IPs and machines, we are able to run the crawler on several computers at the same time to increase the throughout capability of the system. For parallel processing, task scheduling is a crucial problem to solve. For this problem, task scheduling is to assign crawling tasks for various users to machines to keep the balance of the loads of machines. In this section, we will discuss the parallelization strategy for the crawler techniques presented before. We propose load balance methods to make the crawler loads balanced on multiple machines. In the following part of this section, first, we discuss parallel optimization of Poisson process model (in Section 5.1). As for the Hash model, it focuses on scheduling crawling one user, rather than a large group of users as Poisson process model does. It is not necessary to crawl one user with multiple machines, because the resource required to crawl one user is very few. We can easily parallelize such process by using a few machines while every machine crawls different users. Second, we propose two crawler system architectures (the centralized and distributed system), to make the crawler work in parallel (in Section 5.2.1). Both the Poisson process model and Hash model can be applied to the two system architecture. 5.1. Parallel to Poisson Process Model When the crawler development is based on Poisson process model as in Section 4.1, the figure of the message frequency and crawl sequence is like organ pipes as Figure 5 shows. The benefit of such model is the parameters 14 Figure 5: Organ Pipes in Poisson Process Model are simple and the computation resource requirement for the parameters is small. The hight in 5 is the changing rate λ in Poisson process. For the OSN, the height means the user post frequency. By analyzing such model, we have following observations. 1. For those inactive and unimportant OSN users, we can collect their information at a low speed, e.g. once a month. 2. The λ, or post frequency, can be easily predicted according to the historic data of the target user. 3. Such a prediction does not cost much computing resource, what we need to do is to count how many messages the user post, and how long the time period is during his post behavior. Thus we can improve our crawler efficiency without calculating a lot. The experiment shows it is 5.56% to 12.14% better than a Round-and-Robin style. To make the best of the parallelization, we attempt to schedule the load for every machine as balanced as possible. We propose two methods to achieve this goal, the Round-and-Robin method and the set-devision method. 5.1.1. Round-and-Robin method user to the machines in Round-and-Robin style. A intuitive idea to allocate the tasks is to assign the crawl task of each All crawl tasks S={u1, u2, ..., uk}, each element in which is a crawl task for a user. The number of machines is denoted by n. To make these computers 15 Figure 6: Round-and-Robin Method to Parallel Poisson Process Model into Two Parts work in parallel, we want to divide the sequence S into n parts, and then make each of the n machines pick up one part and crawl for the users in this part. The Round-and-Robin method is to divide the sequence: For machine i, we schedule machine it to crawl user uj(j ≤ k) if j mod n = i. 0 , ...uD 4 ) and P art1 uD Thus we can get n crawl lists, each of which is for one machine. Figure 6 describes an example of the algorithm. At the beginning, the to-crawl sequence of 6 users is uD 5 , and we divide the users into two 1 , uD parts: P art0 ( uD in P art0, i mod 2 is 0, and for the user uD in P art1 i mod 2 is 1. We can conduct two i machines, one to crawl P art0 and another to P art1. Thus we can crawl the uD 0 , ...uD the average post frequency difference between two adjoining users fi+1 − fi is a constant ∆, where fi is the post frequency of user ui. In fact, the more users we count, the more stable fi+1 − fi is. Then the workload difference between P art0 and P art1 Assume that in the users sequence sorted by their post frequency u0, u1, ..., un, 5 in parallel. 0 , uD 2 , uD 3 , uD 5 . For the user uD i (cid:88) P art0 −(cid:88) P art1 =  0 n mod 4 = 0 n mod 4 = 1 f0 −∆ n mod 4 = 2 f0 − ∆ n mod 4 = 3 (1) Proof. We proof Equation 1 in these four cases. For the convenience of dis- cussions, we further divide P art0 and P art1 into two segments respectively: P art0A and P art0B, P art1A and P art1B. We use fi to represent the post frequency of user ui, f D i to the frequency 16 (cid:26) fi∗2 of user uD i in the Algorithm 1. And there is f D i = f2(n−i)−1 In the first case, n mod 4 = 0. (cid:98) n+1 2 (cid:99)= n workloads of the four parts are shown as follows. i < n+1 i ≥ n+1 2 2 2 and n 2 mod 2=0. Thus, the WP art0A = f D 0 + f D 2 + ... + f D = f0 + f4 + ... + fn−4 n 2 −2 WP art1A = f D 1 + f D 3 + ... + f D = f2 + f6 + ... + fn−2 n 2 −1 (cid:125) (cid:125) (cid:123)(cid:122) (cid:123)(cid:122) n 4 − 1 items n n 4 − 1 items + f D (cid:123)(cid:122) 4 − 1 items n (cid:123)(cid:122) n 4 − 1 items (cid:125) (cid:125) WP art0B = f D n 2 2 +2 + ... + f D n−2 2 +2)]−1 + ... + f3 = f2(n− n = fn−1 + fn−5 + ... + f3 2 )−1 + f2[n−( n WP art1B = f D n n 2 +1 + f D 2 +3 + ... + f D n−1 = f2[n−( n 2 +1)]−1 + f2[n−( n 2 +3)]−1 + ... + f1 = fn−3 + fn−7 + ... + f1 (cid:124) (cid:124) (cid:124) (cid:124) (cid:124) Then the difference of the workloads of P art0 and P art1 is WP art0 − WP art1 = WP art0A + WP art0B − (WP art1A + WP art1B ) = [WP art0A − WP art1A] + [WP art0B + WP art1B ] (cid:124) (cid:125) = [(f0 − f2) + (f4 − f6) + ... + (fn−4 − fn−2)] (cid:123)(cid:122) + [(fn−1 − fn−3) + (fn−5 − fn−7) + ... + (f3 − f1)] (cid:125) n 4 − 1 items (cid:123)(cid:122) n 4 − 1 items 17 = −( = 0 n 4 − 1)2∆ + ( − 1)2∆ n 4 Since the WP art0 and WP art1 mean the (cid:80) P art0 and (cid:80) P art1 in Equa- tion 1, when n mod 4 = 0, the(cid:80) P art0 −(cid:80) P art1 = 0 . In the second case, n mod 4 = 1. (cid:98) n+1 2 (cid:99)= n+1 the workloads of the four parts are shown as follows. 2 and n+1 2 mod 2=0. Thus, WP art0A = f D 0 + f D 2 + ... + f D = f0 + f4 + ... + fn−1 n+1 2 −1 WP art1A = f D 1 + f D 3 + ... + f D = f2 + f6 + ... + fn−3 n+1 2 −2 (cid:125) (cid:125) n−1 4 items n−5 4 items (cid:124) (cid:124) (cid:124) (cid:124) (cid:123)(cid:122) (cid:123)(cid:122) (cid:123)(cid:122) (cid:123)(cid:122) (cid:124) WP art0B = f D n+1 n+1 2 +1 + f D 2 +3 + ... + f D n−1 2 +3)]−1 + ... + f2[n−(n−1)]−1 2 +1)]−1 + f2[n−( n+1 WP art1B = f D = f2[n−( n+1 = fn−4 + fn−8 + ... + f1 n−5 4 items 2 +2 + ... + f D n−2 2 n+1 n+1 + f D = f2(n− n+1 2 )−1 + f2[n−( n+1 = fn−2 + fn−6 + ... + f3 (cid:125) (cid:125) n−5 4 items 2 +2)]−1 + ... + f3 Then the difference of the workloads of P art0 and P art1 is WP art0 − WP art1 = WP art0A + WP art0B − (WP art1A + WP art1B ) = [WP art0A − WP art1A] + [WP art0B + WP art1B ] = [f0 + (f4 − f2) + (f8 − f6) + ... + (fn−1 − fn−3) (cid:125) ] (cid:123)(cid:122) items n−5 4 18 +[(fn−4 − fn−2) + (fn−8 − fn−6) + ... + (f1 − f3)] (cid:123)(cid:122) n−5 4 items n − 5 (2∆) − n − 5 (2∆) (cid:125) = f0 + 4 Since the WP art0 and WP art1 mean the (cid:80) P art0 and (cid:80) P art1 in Equa- tion 1, when n mod 4 = 1, the(cid:80) P art0 −(cid:80) P art1 = f0 . = f0 4 In the third case, n mod 4 = 2. (cid:98) n+1 2 (cid:99)= n workloads of the four parts are shown as follows. 2 and n 2 mod 2=1. Thus, the (cid:124) (cid:124) (cid:124) (cid:124) (cid:124) (cid:123)(cid:122) (cid:123)(cid:122) (cid:123)(cid:122) (cid:123)(cid:122) WP art0A = f D 0 + f D 2 + ... + f D = f0 + f4 + ... + fn−2 n 2 −1 n−2 4 items WP art1A = f D 1 + f D 3 + ... + f D = f2 + f6 + ... + fn−4 n 2 −2 WP art0B = f D n n−6 4 2 +1 + f D items 2 +3 + ... + f D n−2 2 +3)]−1 + ... + f3 2 +1)]−1 + f2[n−( n = f2[n−( n = fn−3 + fn−7 + ... + f3 n WP art1B = f D n 2 2 +2 + ... + f D n−1 2 +2)]−1 + ... + f1 = f2(n− n = fn−1 + fn−5 + ... + f1 2 )−1 + f2[n−( n items n−6 4 + f D n n−2 4 items (cid:125) (cid:125) (cid:125) (cid:125) Then the difference of the workloads of P art0 and P art1 is WP art0 − WP art1 = WP art0A + WP art0B − (WP art1A + WP art1B ) = [WP art0A − WP art1A] + [WP art0B + WP art1B ] 19 = [(f0 − f2) + (f4 − f6) + ... + (fn−6 − fn−4) +fn−2] (cid:123)(cid:122) n−6 4 items (cid:124) (cid:125) (cid:123)(cid:122) n−6 4 items n − 6 )(−2∆) + fn−2] + [−fn−1 + ( )(2∆)] 4 +[−fn−1 + (fn−3 − fn−5) + (fn−7 − fn−9) + ... + (f3 − f5) ] (cid:125) n − 6 4 = [( = fn−2 − fn−1 = −∆ Since the WP art0 and WP art1 mean the (cid:80) P art0 and (cid:80) P art1 in Equa- tion 1, when n mod 4 = 2, the(cid:80) P art0 −(cid:80) P art1 = −∆ . In the forth case, n mod 4 = 3. (cid:98) n+1 2 (cid:99)= n+1 workloads of the four parts are shown as follows. 2 and n+1 2 mod 2=0. Thus, the (cid:124) (cid:124) (cid:124) (cid:124) (cid:124) WP art0A = f D 0 + f D 2 + ... + f D = f0 + f4 + ... + fn−3 n+1 2 −2 n−3 4 items WP art1A = f D 1 + f D 3 + ... + f D = f2 + f6 + ... + fn−1 n+1 2 −1 WP art0B = f D items 2 +2 + ... + f D n−1 n−3 4 + f D = f2(n− n+1 2 )−1 + f2[n−( n+1 = fn−2 + fn−6 + ... + f1 n+1 n+1 2 (cid:123)(cid:122) (cid:123)(cid:122) (cid:123)(cid:122) (cid:123)(cid:122) (cid:125) (cid:125) (cid:125) (cid:125) WP art1B = f D n+1 2 +1 + f D n−3 4 items 2 +3 + ... + f D n−2 2 +3)]−1 + ... + f3 2 +1)]−1 + f2[n−( n+1 n+1 = f2[n−( n+1 = fn−4 + fn−8 + ... + f3 n−7 4 items 2 +2)]−1 + ... + f2[n−(n−1)]−1 Then the difference of the workloads of P art0 and P art1 is 20 WP art0 − WP art1 = WP art0A + WP art0B − (WP art1A + WP art1B ) = [WP art0A − WP art1A] + [WP art0B + WP art1B ] (cid:125) = [(f0 − f2) + (f4 − f6) + ... + (fn−3 − fn−1) ] (cid:123)(cid:122) (cid:124) +[(fn−2 − fn−4) + (fn−6 − fn−8) + ... + (f5 − f3) +f1] (cid:125) n−3 4 items (cid:123)(cid:122) items (−2∆) + [( )(2∆) + f1] n−7 4 n − 7 4 (cid:124) n − 3 4 = = f1 − 2∆ = f0 − ∆ Since the WP art0 and WP art1 mean the (cid:80) P art0 and (cid:80) P art1 in Equa- tion 1, when n mod 4 = 3, the(cid:80) P art0 −(cid:80) P art1 = f0 − ∆ . The workload difference between the two parts depends on the difference between the single user's post frequency ∆ and the lowest post frequency f0. The Round-and-Robin algorithm has two advantages. First, with n in- creasing, the difference in workloads between two machines would not in- crease. This property could assure the workload balance is still assured with large data size. Second, the workload difference is negligible to a crawling computer. In a real crawler, each machine crawls more than one thousand users a day, and the difference of one user is not influential. The round-robin method only requires to scan the posting frequencies of users only once to partition each user ui into P arti mod k. Hence the space and time complexity for this algorithm is both O(n), where n is the number of users in the sequence. In some extreme cases, there are a few high active users, the load balance will be difficult. Figure 7 shows such case. The user u3 is very active while other users are quiet silent on OSN. And the difference between P art0 and P art1 are larger than in Figure 6. Hence the load of two crawling sequences divided by the Round-and-Robin method is difficult to balance. However, this is hardly met in the real crawling because of two reasons: First, from the experimental results, the most active user among 88779 users post 2051 messages in a period of 4 years. Comparing with the workload 21 Figure 7: Round-and-Robin Method to Parallel Poisson Process Model Into Two Imbal- anced Parts Figure 8: Round-and-Robin Method to Parallel Poisson Process Model into Four Parts of a machine as millions of messages each day, Two thousand messages are not influential to the workload a crawling machine. Therefore even the highest active users would hardly damage the load balance. Second, in practise, the messages of much more users are to be crawled than the experiments. The more we collect, the more balance the Round-and-Robin method are. In cases that we need to divide the Round-and-Robin model into multiple parts, we can do the division recursively. First, we divide the model into two parts, and then, we apply the same method to divide the two parts into four parts, and then eight or more parts. Figure 8 describes such a division. At the beginning, there is just one part, and after Step 1, there are two parts, and after Step 2, there are four. Thus we can crawl the original users with four machines at the same time. This method can only divide the model into a power of 2 parts. In face, since the number of machines is often a power of 2, the method is practical for such cases. As for the time and space complexity, we proof that this algorithm is a PTAS as follow: Theorem 2. The algorithm to parallel Poisson process model into multiple 22 parts is a PTAS. Proof. First, we attempt to prove that in the ith partition, the size of the largest share is at most (1+(cid:48))i n 2i and the size of the smallest share is at most (1 − (cid:48))i n 2i . We prove this statement with induction. As the basic step, for the first partition, according to the approximate ratio of FPTAS algorithm of SSP [21], the size of the smaller part should be larger than (1 − (cid:48)) n 2 . Accordingly, the size of the larger part is smaller than n− (1− (cid:48)) n 2 =(1 + (cid:48)) n 2 . The inductive assumption is that in the (i− 1)th step, the size of the largest share is at most (1 + (cid:48))i−1 n 2i−1 and the size of the smallest share is at most (1 − (cid:48))i−1 n 2i−1 . According to the approximate ratio of FPTAS of SSP, the size of the smallest share of this step should be smaller than the lower bound of the smallest share, which is (1− (cid:48))· (1−(cid:48))i−1 n =(1− (cid:48))i n 2i−1 2i . For the same reason, the size of the largest share of this step should be larger than the upper bound of the largest share, which is (1 + (cid:48)) · (1+(cid:48))i−1 n =(1 + (cid:48))i n 2i−1 2i . Then the statement is proven. Then, we prove that the time complexity of the algorithm is in polynomial time of n, k. All the algorithm has (cid:100)log k(cid:101) steps. The time complexity of step i is the polynomial time of n and k, since the number of shares is 2i ≤ k and time complexity is in the polynomial time of f racn2i and 1 (cid:48) . Since there are at most (cid:100)log k(cid:101) steps. The total time complexity is in polynomial time of n and k. 2 2 Then we attempt to prove that the ratio of sizes of the largest share and the smallest share is smaller than a 1 +  with a given . Since in the best case, the ratio of sizes of the largest share and the smallest share equals to 1. Thus the ratio bound is 1 + . the smallest share is at most (1 − (cid:48))i n largest share and the smallest share is at most (1+(cid:48))((cid:100)log k(cid:101)) 2i and the size of 2i in step i, the ratio of the sizes of the 1−(cid:48) )((cid:100)log k(cid:101)). (cid:100)log k(cid:101) , we have (1 + R)(cid:48) = 1 − R. Thus, Since the size of the largest share is at most (1 + (cid:48))i n (1−(cid:48))((cid:100)log k(cid:101))=( 1+(cid:48) log(1+) 1+R , where R = 2 R = 1+(cid:48) log(1+) Since (cid:48) = R−1 1−(cid:48) . That is, (cid:100)log k(cid:101) = 1+(cid:48) 1−(cid:48) . 2 (cid:100)log k(cid:101) =log 1+(cid:48) Then log(1+) (cid:100)log k(cid:101) log 1+(cid:48) 1−(cid:48) . We have log(1 + )=(cid:100)log k(cid:101) log 1+(cid:48) 1−(cid:48) =( 1+(cid:48) 1−(cid:48) . Thus 1 + 1−(cid:48) )((cid:100)log k(cid:101)). It shows that the ratio of the sizes =2log(1+)=2 of the largest share and the smallest share is at most 1 + . Thus the ratio bound of the algorithm is 1 + . 23 5.1.2. Set-Division method As discussed in the Section 5.1.1, the round-robin strategy divides the previous part into several small parts, and each smaller parts are as the same large as possible. The Set-Division method tries to solve the division by separating the previous part into a few number of smaller parts, and each smaller part contains different number of users. If we treat the user post frequency as a set of integers, then the job schedule problem (JS for brief) is defined as follows. Given a set of integers S = u1, u2, ..., un, how to divide S into k sets S1, S2, ..., Sk to make the difference between the k sets (cid:88) 1≤i<j≤k (cid:88) i(cid:48)∈Si i(cid:48) − (cid:88) j(cid:48)∈Sj j(cid:48) is the least. We attempt to prove its hardness as Theorem 3. Theorem 3. JS is a NP-hard problem. Proof. We attempt to reduce the Number Partitioning Problem (NPP)[22] to a special case of JS with k=2. For a NPP problem with a given input of a set S={a1, a2, ···, an} with integers, we construct a input of JS with the input set of integers as S and k = 2. The solution of such JS, S1 and S2, has minimal S1 − S2. Thus this is a solution of such NPP problem. Since NPP is an NP-hard problem [23] and the reduction can be accomplished in polynomial time clearly, JS is an NP-hard problem. The problem can be converted to the Subset Sum Problem (SSP). That is, given a set of integers S = u1, u2, ..., un, how to select m numbers from S so that those m numbers are close to but no more than a given constant c [24]. The SSP is NP-Hard [23], but it can be solved in pseudo-polynomial time. [24] gives such algorithm, and its time complexity is O(Max(n − log2c2)c, c ∗ log2c), space complexity is O(n + c). 5.2. Parallel System Architectures In this subsection, we propose two parallel system architectures, a cen- tralized and distributed ones. 24 In the centralized architecture, the clients are connected to a server, but all of them work independently. While in the distributed architecture, all the computers work independently. So you can apply either the Poisson process model or the Hash model to the two architectures, or apply the two models at the same time. The major difference between the two architectures is whether the system has a central server. For the centralized system, the server maintains the crawling sequences of all users, and assigns the crawling jobs to clients. The clients are only responsible to do the crawling job sent by the server. For the distributed system, every machine i is in charge of a crawling task set Si. They determine the assignment the task in Si to machines. Note for each task u in Si, machine i just determines which machine will perform u but u does not have to be performed on machine i. In this section, we will introduce these two architectures in Section and Section, respectively. 5.2.1. Centralization Parallel System In the centralized crawler system, a center server is required to maintain the target crawling user sequence and schedule all clients' work. The central server goes through the Poisson process model or Hash model and updates the model parameters. It decides 1) who is the next user to crawl; and 2) which machine to crawl the user. And other client machines all have a to-crawl user list. Each client crawls information for the users in the user list one by one. To make the best use of the API quota, when we want to collect a user's information, we first find the client machine whose to-do list is the shortest, and make it to do the job. Hence the to-do list of each machine can be as the same long as possible, and the workload and the API quota of difference can be more similar. If there is more than one machine with a shortest to-do list, then we randomly select a client to do the corresponding job. In a word, the tasks for the server is: 1) Build the crawling model: Poisson process, Hash Model and so on. 2) Maintain the crawling sequence: decide who is the next user to crawl. 3) Send target user id to clients: let the client whose workload is currently minimal to crawl the target user. 4) Receive data from clients: store the data that clients collected. And the tasks for a client is: 1) Crawl the target user: this is the job sent by the server. 25 Figure 9: The Centralized Crawler Architecture 2) Send the data to the server: so the server can manage the storage. Figure 9 describes such a centralized system. It is convenient for a centralized system to do job scheduling, however, it may not make the best use of the bandwidth of the server. As the task for the server is to compute and update the parameters for models, and that for the clients is to crawl, the limit for the server is computing resource while that for the client is API quota and bandwidth. Therefore, it is possible that the server has run out of its computing resource while the clients still have enough API quota and bandwidth. As a result, the centralized system may not make the best use of all machines. On the other hand, the centralized system has a high requirement to the bandwidth between the server and clients. If we use machines outside laboratory as clients, e.g. the plantlab, then it is hard to guarantee the bandwidth and the clients may lost connection. To avoid the above two disadvantages, we propose a distributed architec- ture in the following subsection. 5.3. Distributed Parallel System In a distributed system, there is no center server. Every machine acts as both a server and client at the same time. 26 Figure 10: The Distributed Crawler Architecture In the centralized architecture, the central server has a long list of OSN users that will be crawled. The server is accessible to the users' data, and it manages the crawling strategy according to the users' behavior and crawling model. As a comparison, the client machines do not have any user list. The client machines are given the target users' names or ids, crawl according to the names or ids, and then return the users' data to the server. In the distributed system, however, every machine has their own user list. All of the machines manage their crawling dependently. They are able to build different models, and rule the crawling strategy according to their own data respectively. In a real crawling system, every machine runs two kinds of process: the Management Process and the Crawling Process. The management process is responsible to the crawling strategy. It visits the users' data that has been collected before, runs crawling model (Poisson process model, Hash model or any other model), decides which user to crawl next, and sends the target user's name or id to the crawling process. The crawling process is only visible to the target user's name or id sent by the management process. The only duty of the crawling process is to crawl the target user, and then send the user's data back to the management process. Because there are much more crawling job than management job, the number of crawling processes is much larger than that of management processes. In other word, the management and crawling process serves like the server and client in the centralized system. Figure 10 describes the distributed architecture of a crawling system. The curves in the figure means the Management Process, while the fold lines means the Crawling Process. Every machine under this architecture works independently, and they can use different crawling strategies of both Poisson process model or Hash model. They also have different target user list. They decide the crawling sequence of the users, and also do the crawling job assigned to it. A number of processes are run on the computers at the same time. There 27 are two kinds of processes: 1) a computing process to maintain the model and adjust algorithm parameters, and 2) a few crawling processes to collect information from the online social network. Because nowadays CPU always have multicores, to improve the performance of the crawling system, we can let the processes, no matter computing or crawling ones, run on different CPU cores. As for the workload, in the centralized system, our purpose is to make the workload as balanced as possible as we discussed in Section 5.1.1. The centralized system is always built in the laboratory, because it requires a high speed network connection the server and clients. In such cases, the client machines, or the clusters in the laboratory always have the same performance. And to make the best use of the same machines, we just need to make the load as same as possible. The distributed system, however, is always built outside the laboratory, for it has a lower requirement of the machines and network. Under such circumstance, it is necessary to manage the workload according to the ma- chine's performance. In a distributed system, since the crawling work of every machine is independent, the workload is independent as well. To make the workload between the machines balance, you can adjust by 1) switch the crawling algorithm, and 2) add or remove users from the user list of the com- puters. For example, if you have a lot of inactive users to collect, and you want to crawl them just only once, then choose the Poisson process model, otherwise choose the Hash model. And if a computer run out of its API quota, you can remove some users from its user list, and add the users to another computer whose API quota is enough. However, the distributed architecture brings a problem: the data is stored distributively in many machines, which means we have to do more work to collect all the data in every machine. In a word, the centralized system works better in laboratory, and the distributed system is more suitable outside the laboratory. 6. Experimental Evaluation To verify the effectiveness and efficiency of our strategies, we perform experiments in this section. The experiments are performed on a PC with 2.10 GHz Intel CPU and 4G RAM. We crawl the Weibo.com, which is one of the hottest OSN in China. The Weibo has 503 million registered users in 2012.12 and about 100 million messages are post everyday [25]. 28 We crawled the last 2,000 messages of 88,799 randomly selected users. The result shows that 80,616,076 messages are collected. 6.1. Experimental Results for Poisson Process Model To test the effectiveness of Poisson process model, we conducted the Pois- son process model twice. First, we crawled the 10,000 users in a period of 2 months from 1012.11.01 to 2013.01.01 , and accessed every user once to get the last 100 messages. From observations, the Poisson process model crawled 421,722 messages, while the Round-and-Robin style crawled 376,053 messages. Thus the Pois- son process model is 12.14% better. Second, we crawled the 88,799 users in a period of 4 years from 2009.08.31 to 2013.09.01, and accessed every user once. From observations, the Poisson process model crawled 7,369,498 messages, while the Round-and-Robin style crawled 7,147,965 messages. Thus the Poisson process model is 3.10% better. 3.10% is lower than 12.14%. In fact, when the experimental period lasts longer and the total messages number grows larger, there will be more mes- sages to collect, and every time we can access more messages. And if we can collect more than 100 messages every time, the experimental result will be the same. Therefore, the longer the experimental period, the more similar the results of various methods will be. 6.2. Hash Model We crawl the 10,000 users by hash model. We assume the crawling limit is 100 messages at one crawling, the longest crawling span threshold s is 30 days, and the weight for the last one day (in the example, it is 0.5) ranges from 0.4 to 0.9 step by 0.1. The result is shown in Table 1. For comparisons, we also conduct the experiment for RR, and crawl one user 2 to 5 times during the experiment period. The result is described in Table 2. The data in Table 1 shows that with the weight increases, the total crawl time increases and more messages will be crawled, while the crawling ef- ficiency decreases. Thus the weight can be considered as a parameter to adjust the crawling efficiency and the limited crawling resource such as the API restriction. The data in Table 2 shows that the crawling efficiency for the RR style method is reasonable stable when the crawling frequency is low. 6.3. Parallelization We show the experimental result of the parallelization methods discussed in Section 5 as follow: 29 Table 1: The Hash Model Experiment Results Weight Message Number Total Crawl Time Avg #Msg. with 0.9 0.8 0.7 0.6 0.5 0.4 1451435 1417908 1368783 1323012 1255509 1175464 50421 44605 39446 35421 32211 29822 1 crawling 28.79 31.79 34.70 37.35 38.98 39.42 Table 2: The RR Style Method Experiment Results 1 User Crawl Time Total Crawl Message Number Avg. #Msg. 5 4 3 2 Time 50005 40004 30003 20002 939964 818039 652641 411086 With 1 Crawling 18.80 20.45 21.75 20.55 6.3.1. Parallel to Poisson Process Model First, we calculated the post frequencies (how many messages users post in a day) of 1000 to 7000 randomly selected user step by 1000, and tried both Round-and-Robin method and randomly select method to divide the frequencies into two parts. Table 3 shows the result. From Table 3, we can find that the Round-and-Robin method is much better than the Random method. In the worst experimental case (728.22 and 83.47), the workload difference of Round-and-Robin method is only 11.46% of that of random method. Second, we divide the 1000, 2000, 4000 and 8000 post frequencies into 16 parts recursively using both Round-and-Robin method and random method. Table 4 shows the result. From Table 4, we can find that the Round-and-Robin method is much better than the Random method. In the worst experimental case (2557.92 and 339.55), the workload difference of Round-and-Robin method is only 13.27% of that of random method. 30 Table 3: The Round-and-Robin Parallelization Results 1 User Num. Fre. Tot. Random Method Diff. RR Diff. 145.11 37.54 37.03 85.72 83.47 430.90 343.31 49943.17 96473.30 140484.31 187524.68 237834.48 289173.84 335352.75 1995.68 3413.03 5828.93 5421.92 728.22 8205.22 5651.32 10000 20000 30000 40000 50000 60000 70000 Table 4: The Round-and-Robin Parallelization Results 2 User Num. Fre. Tot. Random Method Diff. RR Diff. 339.55 276.63 185.39 643.81 49943.17 96473.30 187524.68 381714.54 2557.92 3096.89 3264.10 6585.32 10000 20000 40000 80000 6.3.2. Parallel to Centralization Architecture To test the efficiency of the centralization architecture, we use 1, 2, 4, 8 and 16 machines respectively and crawl 2,000 users with one machine during a period of one year (from 2012.09.01 to 2013.09.1). Table 5 and Figure 11 describe the experimental result. In Table 5, the 'Machine Num.' means the total number of machines in the experiment, the 'Tot. Messages' means the number of total messages that are crawled, and the 'Workload Diff.' means the difference between the maximum and minimum workload of the machines. In the Figure 11, the x-axis means the number of experimental machines, and the y-axis means the total messages crawled. From Table 5 and Figure 11, we can find that the speed-up ratio is almost Table 5: The Centralized Architecture Experimental Result Machine Num. Tot. Messages Workload Diff. 1 2 4 8 16 0 627 4079 3530 5008 22474 42495 83271 172473 344540 31 Figure 11: The Centralized Architecture Experimental Result Table 6: The Distributed Architecture Experimental Result Machine Num. Tot. Messages Workload Diff. 1 2 4 8 16 20916 43886 87679 177534 348800 0 1404 3575 4271 5269 linear. 6.3.3. Parallel to Distributed Architecture To test the efficiency of the distributed architecture, we use 1, 2, 4, 8 and 16 machines respectively and crawl 2,000 users with one machine during a period of one year (from 2012.09.01 to 2013.09.1). Table 6 and Figure 12 describe the experimental result. The raws in Figure 6 and axises in Figure 12 have the same meaning in Figure 6 and Figure 12 mentioned in Section 6.3.2 From the table, we can find that the speed-up ratio is almost linear. Compare the distributed architecture with the centralized architecture, we find the workload difference of the distributed one is larger than the centralized one. For the centralized system, the minimal slot to manage the workload is one crawling operation, while for the distributed system it's one target user. We may crawl one user several times, so the slot for the centralized system is smaller and the workload is more balanced. 32 7RWDOt0HVVDJHVt(uNNt0HVVDJHV10DFKLQHt1XPEHU Figure 12: The Distributed Architecture Experimental Result 7. Conclusion And Future Work To use the information in OSN effectively, it is necessary to obtain fresh OSN in-formation. However, OSN crawler is quite different from web crawlers for the change rate is faster and the requirements for the latest messages are much more intensive. Therefore, the traditional web crawl method cannot be applied for OSN information crawling. To obtain fresh information in OSN with resource constraint, we classify users according to their behaviors. Their behaviors are modeled and crawling algorithms are proposed according to the models. Experimental results show that the Hash model is about 50% better than the Round-and-Rabin method, and the Poisson process model is 12.14% better than the RR method with randomly selected users. And the parallelization method effectively controls the workload difference of the machines in the crawler system. What's more, the centralized and distributed architectures all show a linear speed up with the number of machines. There are some possible future research directions. One is to crawl with different weight for different users, for the celebrities are more influential. How to define the weights for users to crawl optimally remains a challenge. Another direction is to obtain the hottest messages as early as possible. Study of information transmit is required so that we can predict the hot pot in OSN. As for the crawler system development, the centralized and distributed architectures may be tested with more machines and crawl more users, even the whole OSN users if possible. 33 0HVVDJHs1XPEHUsrnns0HVVDJHV(0DFKLQHs1XPEHU References [1] Facebook, http://www.facebook.com/press/info.php?statistics, 2013. [2] S. G. Set., http://snap.stanford.edu/data/, 2013. [3] J. Leskovec, Social media analytics: tracking, modeling and predicting the flow of information through networks, in: Proceedings of the 20th international conference companion on World wide web, ACM, 2011, pp. 277 -- 278. [4] Spinn3r, http://www.icwsm.org/data/, 2013. [5] C. Byun, H. Lee, Y. Kim, Automated twitter data collecting tool for in: Proceedings of the 2012 ACM Re- data mining in social network, search in Applied Computation Symposium, ACM, 2012, pp. 76 -- 79. [6] T. Sakaki, M. Okazaki, Y. Matsuo, Earthquake shakes twitter users: real-time event detection by social sensors, in: Proceedings of the 19th international conference on World wide web, ACM, 2010, pp. 851 -- 860. [7] E. Aramaki, S. Maskawa, M. Morita, Twitter catches the flu: Detecting influenza epidemics using twitter, in: Proceedings of the Conference on Empirical Methods in Natural Language Processing, Association for Computational Linguistics, 2011, pp. 1568 -- 1576. [8] D. Denev, A. Mazeika, M. Spaniol, G. Weikum, Sharc: framework for quality-conscious web archiving, Proceedings of the VLDB Endowment 2 (2009) 586 -- 597. [9] C. Olston, S. Pandey, Recrawl scheduling based on information longevity, in: Proceedings of the 17th international conference on World Wide Web, ACM, 2008, pp. 437 -- 446. [10] Facebook, https://dev.twitter.com/docs/rate-limiting, 2013. [11] M. Boanjak, E. Oliveira, J. Martins, E. Mendes Rodrigues, L. Sarmento, Twitterecho: a distributed focused crawler to support open research with twitter data, in: Proceedings of the 21st international conference companion on World Wide Web, ACM, 2012, pp. 1233 -- 1240. 34 [12] P. Noordhuis, M. Heijkoop, A. Lazovik, Mining twitter in the cloud: A in: Cloud Computing (CLOUD), 2010 IEEE 3rd Interna- case study, tional Conference on, IEEE, 2010, pp. 107 -- 114. [13] D. H. Chau, S. Pandit, S. Wang, C. Faloutsos, Parallel crawling for on- line social networks, in: Proceedings of the 16th international conference on World Wide Web, ACM, 2007, pp. 1283 -- 1284. [14] G. Dziczkowski, L. Bougueroua, K. Wegrzyn-Wolska, Social network- an autonomous system designed for radio recommendation, in: Com- putational Aspects of Social Networks, 2009. CASON'09. International Conference on, IEEE, 2009, pp. 57 -- 64. [15] J. Cho, H. Garcia-Molina, L. Page, Efficient crawling through url or- dering, Computer Networks and ISDN Systems 30 (1998) 161 -- 172. [16] J. Cho, H. Garcia-Molina, Estimating frequency of change, ACM Trans- actions on Internet Technology (TOIT) 3 (2003) 256 -- 290. [17] C. Castillo, M. Marin, A. Rodriguez, R. Baeza-Yates, Scheduling algo- rithms for web crawling, in: WebMedia and LA-Web, 2004. Proceedings, IEEE, 2004, pp. 10 -- 17. [18] J. Cho, U. Schonfeld, Rankmass crawler: a crawler with high person- alized pagerank coverage guarantee, in: Proceedings of the 33rd inter- national conference on Very large data bases, VLDB Endowment, 2007, pp. 375 -- 386. [19] R. Baeza-Yates, A. Gionis, F. P. Junqueira, V. Murdock, V. Plachouras, F. Silvestri, Design trade-offs for search engine caching, ACM Transac- tions on the Web (TWEB) 2 (2008) 20. [20] J. Cho, A. Ntoulas, Effective change detection using sampling, in: Proceedings of the 28th international conference on Very Large Data Bases, VLDB Endowment, 2002, pp. 514 -- 525. [21] C. E. Leiserson, R. L. Rivest, C. Stein, T. H. Cormen, Introduction to algorithms, The MIT press, 2001. [22] S. Mertens, The easiest hard problem: Number partitioning, Computa- tional Complexity and Statistical Physics 125 (2006) 125 -- 140. 35 [23] M. R. Gary, D. S. Johnson, Computers and intractability: A guide to the theory of np-completeness, 1979. [24] N. Y. Soma, P. Toth, An exact algorithm for the subset sum problem, European Journal of Operational Research 136 (2002) 57 -- 66. [25] Wikipedia, http://en.wikipedia.org/wiki/Sina_Weibo, 2013. 36
1807.09586
3
1807
2019-07-10T13:20:52
Perturb and Combine to Identify Influential Spreaders in Real-World Networks
[ "cs.SI", "cs.LG", "stat.ML" ]
Some of the most effective influential spreader detection algorithms are unstable to small perturbations of the network structure. Inspired by bagging in Machine Learning, we propose the first Perturb and Combine (P&C) procedure for networks. It (1) creates many perturbed versions of a given graph, (2) applies a node scoring function separately to each graph, and (3) combines the results. Experiments conducted on real-world networks of various sizes with the k-core, generalized k-core, and PageRank algorithms reveal that P&C brings substantial improvements. Moreover, this performance boost can be obtained at almost no extra cost through parallelization. Finally, a bias-variance analysis suggests that P&C works mainly by reducing bias, and that therefore, it should be capable of improving the performance of all vertex scoring functions, including stable ones.
cs.SI
cs
Perturb and Combine to Identify Influential Spreaders in Real-World Networks Antoine J.-P. Tixier École Polytechnique Palaiseau, France Maria Evgenia G. Rossi Fragkiskos D. Malliaros Jesse Read École Polytechnique Palaiseau, France Centrale-Supélec Gif-sur-Yvette, France École Polytechnique Palaiseau, France Michalis Vazirgiannis École Polytechnique Palaiseau, France 9 1 0 2 l u J 0 1 ] I S . s c [ 3 v 6 8 5 9 0 . 7 0 8 1 : v i X r a Abstract -- Some of the most effective influential spreader detection algorithms are unstable to small perturbations of the network structure. Inspired by bagging in Machine Learning, we propose the first Perturb and Combine (P&C) procedure for networks. It (1) creates many perturbed versions of a given graph, (2) applies a node scoring function separately to each graph, and (3) combines the results. Experiments conducted on real-world networks of various sizes with the k-core, generalized k-core, and PageRank algorithms reveal that P&C brings substantial improvements. Moreover, this performance boost can be obtained at almost no extra cost through parallelization. Finally, a bias- variance analysis suggests that P&C works mainly by reducing bias, and that therefore, it should be capable of improving the performance of all vertex scoring functions, including stable ones. Index Terms -- Influential Spreader Detection, Perturb and Combine, Bootstrap, Bagging, Machine Learning, Ensemble Learning, Degeneracy I. Introduction Influential spreaders are nodes that can diffuse information to the largest part of the network in a minimum amount of time. Detecting influential spreaders is an important task with numerous real-world applications. Well known examples include epidemiology [1], viral marketing [2], social media analysis [3], expert finding [4], and keyword extraction [5]. Intuitively, one could think that nodes with many connec- tions are the most influential spreaders, and use node centrality criteria such as the degree or PageRank as a measure of influence. However, there are cases when node degree is not a good spreading predictor. Consider for example a hub node located at the periphery of the network. As shown in Fig. 1, nodes ∗ and ∗∗ both have same degree (5) and high PageRank scores (resp. in (6.73, 9.05] and (9.05, 11.4]). However, node ∗ lies in a much more central location and is therefore a much better spreader, which is captured by its higher core number (3 vs 1) but not by degree or PageRank (the PageRank score of node ∗∗ is even greater than that of node ∗). As they inherently capture cohesiveness, graph degeneracy algorithms are very effective at locating influential spreaders (and better than degree and PageRank) [3], [6] -- [8]. Their efficiency, combined with their low time complexity, has motivated a new line of research [9]. The most famous member of the graph degeneracy family is the k-core algorithm. A k-core of a graph G is defined as the Accepted as long paper (oral presentation) at ASONAM 2019. Fig. 1: Degree vs PageRank vs k-core. Labels are degrees. maximal subgraph of G in which every vertex v has at least degree k [10]. As shown in Fig. 2, the k-core decomposition of G is the set of all its cores from 0 (G itself) to kmax (its main core). It forms a hierarchy of nested subgraphs whose cohesiveness increase with k. A node has core number k if it belongs to a k-core but not to a (k + 1)-core. Fig. 2: Illustration of the k-core decomposition. Here, kmax = 3. The basic k-core algorithm has time complexity linear in the number of edges, but it is unweighted, i.e., it uses as the degree of v the count of its neighbors. A generalized version has been proposed by [11] for any local monotone vertex property function, with still very affordable time complexity O(E log(V)). By using the sum of the weights of the incident edges as the vertex property function, we obtain the weighted k-core decomposition. However, graph degeneracy algorithms are unstable to small perturbations of the network structure, such as the removal of a small fraction of edges from the network [12], [13]. This opens the gate to improvement: indeed, it is well known in Machine Learning that the performance of unstable algorithms can be llllllllllllllllllll55*54444333311115**1111llllPageRank scores(2.07,4.41](4.41,6.73](6.73,9.05](9.05,11.4]Core numbers123 improved by using Perturb and Combine (P&C) strategies. Therefore, inspired by the bootstrap aggregating (bagging) method, we propose a procedure that first creates many per- turbed versions of a given graph, then applies a node scoring function separately to each graph, and finally aggregates the results back into more robust scores. Our contributions are fourfold: (1) we propose what is, to the best of our knowledge, the first application of P&C to networks, (2) experiments on large social networks and small word co-occurrence networks reveal that for k-core, generalized k-core, and PageRank, P&C allows to identify better spreaders, (3) our procedure is trivially parallelizable, so performance gains can be obtained at little extra cost, (4) we explain through a theoretical analysis why our P&C strategy is effective. We notice that improvement comes mainly from reducing bias, which implies that P&C for networks could work well for all algorithms, including stable ones. II. Perturb and Combine in Machine Learning In Machine Learning, unstable algorithms are algorithms for which small changes in the training set result in large changes in predictions. These models are also known as low bias- high variance algorithms or strong learners [14]. Decision trees (especially deep, unpruned ones) in classification and regression are good examples of such models. Indeed, adding or removing only a few observations to/from the training set changes the structure, and thus the predictions, of decision trees. It is well known that unstable learners can have their accuracy greatly improved by perturbing and combining. Of all the P&Cs strategies, bootstrap aggregating (bagging) [15] is certainly the most popular, and one of the most effective. It is actually one of the key ingredients of the acclaimed Random Forest model [16]. In the context of decision trees, bagging simply consists in training unpruned trees in parallel on bootstrap samples of the training set. Each bootstrap sample is a perturbed version of the training set which is generated by drawing from it with replacement until a set of the same size is obtained. To issue a forecast for a new observation, the predictions of all the trees are combined, e.g., through averaging in regression and majority voting in classification. Note that instability is mandatory for bagging to function well. For instance, bagging is not effective with nearest-neighbors approaches [15], which are very stable. III. Perturb and Combine for Networks A. Key idea It was shown that the core decomposition of a network is highly sensitive to small perturbations at the edge level such as edge addition and deletion [12]. This property is easy to verify in practice, as illustrated by Fig. 7 in App. C. [13] also demonstrated that the removal of only a tiny fraction of vertices can vastly damage the k-core. Motivated by these observations, we posit that like unstable learners in Machine Learning, degeneracy-based node scoring functions, and more generally any unstable node scoring function, benefits from using a P&C strategy. That is, it is possible to identify better spreaders by aggre- gating node scores computed on multiple perturbed versions of the original network rather than by using the scores com- puted on the original network. We therefore propose a P&C procedure for networks described by Algorithm 1, that features three simple steps: 1) create M perturbed versions of a given graph, 2) separately apply a node scoring function to each graph, 3) aggregate the results. V (cid:55)→ R Algorithm 1 PC-NET (P&C for NETWORKS) Input: original graph G(V, E), M ∈ N, vertex scoring function s : Output: P&C scores spc(1), . . . , spc(n) for the n nodes in V (n = V) 1: B ← empty M × n array Gm ← PERTURB(G) 2: for m ∈(cid:2)1, . . . , M(cid:3) do B(cid:2)m, :(cid:3) ← MINE( Gm, s) 3: 4: 5: end for 6: spc(1), . . . , spc(n) ← COMBINE(B) 7: return spc(1), . . . , spc(n) Perturbation models have been widely used for generating graphs, describing them, and studying their behavior. However, this study is, to the best of our knowledge, the first attempt at using graph perturbation not only for descriptive or generative purposes, but as the first step of a process subsequently involving scoring and combination. Looking at Algorithm 1, it appears immediately that like Random Forest, PC-NET is a meta-algorithm that can trivially be parallelized (for loop in lines 2-5). The P&C scores therefore do not take more time to obtain than the original scores, provided that M workers are available. The only additional cost comes from the PERTURB step in line 3, but it can be implemented efficiently. Details about the PERTURB, MINE, and COMBINE parts (lines 3, 4, and 6) are provided next, in subsections III-B, III-C, and III-D. B. Perturb High-level framework. We used a flexible framework very similar to that used in [12]. It is a general model for edge- based perturbation of which most of the perturbation models found in the literature can be seen as special cases. Not using node-based perturbation makes combination easier, since each node is assigned a score in each perturbed graph. Let G(V, E) be the original graph and G be a random graph model. The corresponding perturbation model Θ(G, G, εa, εd) is defined as: if (u, v) (cid:60)E if (u, v) ∈E (1) (cid:40) (cid:2)(u, v)(cid:3) = PΘ (cid:2)(u, v)(cid:3) (cid:2)(u, v)(cid:3) εaPG εdPG it where PΘ (u, v), PG according to the random graph model G, and εa, εd are the probabilities of edge addition and deletion, respectively. (cid:2)(u, v)(cid:3) is the probability of adding/deleting the edge (cid:2)(u, v)(cid:3) is the probability of selecting the edge (u, v) (cid:2)(u, v)(cid:3), (cid:2)(u, v)(cid:3). By An interpretation can be given as follows: if the edge (u, v) is added with probability εaPG already exists, then it is deleted with probability εdPG and if not, XOR-ing the original graph G with one realization θ ∼ Θ(G, G, εa, εd) of the perturbation model, we obtain the per- turbed graph G = G ⊕ θ. Depending on the random graph model G used, we obtain a different perturbation scheme. Edge weight awareness. To make our approach more flexible, and generalizable to weighted graphs, we used two variants of the above perturbation framework: (1) the first scenario (δw = 0) is exactly the one described above, i.e., it ignores edge weights during the perturbation phase. Edges can only be completely removed or created from scratch; (2) in the second scenario (δw = 1), the perturbation procedure accounts for edge weights. More precisely, a given edge (u, v) can be considered for addition even if it already exists, and can remain in the graph even if it was selected for deletion. In such cases, we simply increment (respectively, decrement) the weight of (u, v) by one standard deviation of all edge weights. Since edges can be selected multiple times, any edge whose weight becomes negative is removed from the graph. In both scenarios, whenever an edge is created, we sample its weight at random from the weights of the edges incident on its endpoints. Random graph models. Plugging the Erdos-Rényi (ER) random graph model [17] into our framework returns the uniform perturbation model. A node is randomly drawn with replacement from V with probability 1/n. On the other hand, using the Chung-Lu (CL) random graph model [18] gives the degree assortative perturbation model. A node is randomly drawn with replacement from V with probability proportional to its weighted degree. In that case, edges are more likely to be created/incremented and deleted/decremented between hubs. For both G = ER and G = CL, self-edges are disregarded. That is, if we select two nodes u and v such that u = v, we discard the pair and select two other nodes. C. Mine Vertex scores can be returned by any node scoring function. However, since perturb and combine strategies in Machine Learning are most effective when used with unstable base learners, we experimented with k-core and weighted k-core (cu and cw in what follows), as these algorithms are both unstable and highly effective at locating good spreaders. Since its rankings are known to be relatively stable to link- based perturbations [19], [20], we also included the weighted PageRank algorithm [21] in our experiments, for comparison purposes (pr in what follows). D. Combine Following common practice in Machine Learning (e.g., bagging regression trees), we compute the P&C score of a node as the average of its scores over the M perturbed graphs. IV. Experiments We tested our P&C strategy on large social networks and small word co-occurrence networks. A. Social Networks We experimented on 3 well-known, publicly available large scale social networks [22] (see Table I). Email-Enron is an email communication network [23] where edges indicate email exchange. Epinions is a social network where edges indicate who trusts whom. In the WikiVote network, edges represent administrator election votes. Since these networks are unweighted, we assigned as edge weights the maximum number of connections of their endpoints. TABLE I: Statistics of the real-world social networks used in this study. d and τ denote diameter and epidemic threshold. G(V, E) Email-Enron Epinions Wiki-Vote V 33, 696 75, 877 7, 066 E 180, 811 405, 739 100, 736 d 11 14 7 cumax 43 67 53 cwmax 18, 931 37, 343 15, 756 prmax 14.95 3.06 4.37 τ × 102 8.4 5.4 7.2 To measure the spreading influence of a node, we simulated diffusion processes using the famous Susceptible-Infected- Recovered (SIR) epidemic model [24]. It is a discrete time model which assumes that at every step, each node falls into one of the following mutually exclusive categories: • Susceptible (S): not yet infected, thus being able to get infected with probability β (infection rate), • Infected (I): capable of contaminating susceptible neighbors, • Recovered (R): after being infected, a node may recover with probability γ (recovery rate). It is then considered as immune and cannot transmit infection anymore. The process iterates until no new node gets infected for two consecutive steps. 1 − β 1 − γ S β I γ R Fig. 3: SIR epidemic model Following [6], [8], we started Ne epidemics from each node in the trigger population to account for the stochastic nature of the SIR model. The results for each node were then averaged over the Ne runs and then again averaged over the trigger population to get a final performance score for a given vertex scoring function. For unweighted and weighted k-core, the trigger population was the maximal k-core subgraph. Since we used averaging as our combination strategy, we rounded up the P&C scores to the nearest integer before extracting the main cores. For PageRank, the trigger population was the 100 nodes with highest scores. We set Ne = 100, the infection rate β close to the epidemic threshold of the network τ = 1 , where λ1 was λ1 the largest eigenvalue of the adjacency matrix [25], and the recovery rate γ to 0.8, as in [6]. We grid searched the following P&C parameters: εa : {0, 0.05, 0.1, 0.2}, εd : {0, 0.05, 0.1, 0.2}, {0, 1}. Excluding M : the εa = εd = 0 cases, this made for 120 combinations. {ER, CL}, and δw : {16, 64}, G : The optimal parameter values were selected as the ones returning the greatest total number of nodes infected during the epidemic. Results. Table II compares the average severity of the epidemic when triggered from the top nodes in terms of their scores in the original networks to that when started from the top nodes in terms of P&C scores, for the best parameters shown in Table VI. Everywhere, using the P&C scores leads to a more severe epidemic. TABLE II: Epidemic severity for unweighted k-core, weighted k-core, and PageRank (top to bottom). +% denotes percent improvement. Network Enron Epinions WikiVote Enron Epinions WikiVote Enron Epinions WikiVote Time Step 8 6 4 2 17 16 29 28 40 37 Scores 10 Total +% P&C 16 89 300 419 269 2,538 3.76 original 14 77 269 401 275 2,446 34 110 245 317 2,436 4.35 P&C 8 30 100 224 301 2,330 7 original P&C 3 8 490 3.47 original 3 8 473 P&C 26 141 407 445 226 2,724 3.52 original 20 110 345 433 253 2,628 146 302 353 2,689 2.42 P&C 11 46 135 286 345 2,624 original 11 42 P&C 5 12 24 19.3 original 4 9 18 P&C 16 86 278 389 266 2,454 4.93 P&C 11 42 132 276 336 2,598 2.04 P&C 5 2.35 5 original 15 80 259 366 255 2,333 original 11 41 127 267 326 2,545 596 original 582 612 513 39 31 50 42 49 48 38 36 11 11 22 22 Moreover, the differences are substantial, comparable with the improvements reported in previous research, e.g., k-truss over k-core [8]. We can also remark that even though the parameters were tuned to maximize the total number of nodes infected during the entire epidemic, nodes with high P&C scores are better spreaders even in the early stages of the diffusion process. Finally, as shown in Fig. 4 for unweighted k-core, the rankings provided by P&C are of better quality than the rankings provided by the original scores, especially for the very top nodes. E.g., on Enron, the top 0.5% (169) P&C nodes contain 75.15% of the 0.5% best spreaders (as returned by SIR), compared to only 61.54% when using the original scores. This means that P&C places more of the most influential spreaders at the very top of the ranking than the original scores. This is a very valuable property, especially in practice, when budget constraints often only allows selecting a limited number of nodes (e.g., in growth hacking and viral marketing). ENRON 85 71 95 WIKIVOTE EPINIONS p 0.25 0.5 0.75 1 1.25 1.5 1.75 2 169 253 337 422 506 590 674 142 212 283 354 424 495 566 190 285 380 475 570 664 759 Fig. 4: Fraction of the p% best spreaders (y axis) contained in the top p% nodes (x axis) in terms of P&C and original scores, for cu. The table shows the number of best spreaders for each p. B. Word co-occurrence networks It has been suggested that the keywords of a document are influential nodes within the word co-occurrence network of that document [5]. Therefore, in this section, we test whether applying P&C to graphs of words improves keyword extraction performance. We define a word co-occurrence network as in [26], [27] (see Fig. 8 in App. D). Each unique term is a node, and two nodes are linked by an edge if they co-occur within a fixed-size sliding window. Edge weights indicate co- occurrence counts. We experimented on the well-known Hulth2003 dataset [28]1, which contains abstracts from the Inspec research article database. We considered the standard validation set of 500 documents and used the uncontrolled keywords assigned by human annotators as ground truth. The mean document size is 120 words and on average, 21 keywords (unigrams) are available for each document. Note that reaching perfect recall is impossible on this dataset. Following [26], we pre-processed each document with part- of-speech (POS) tagging and retained only nouns and adjec- tives. Finally, we Porter stemmed words. We then built a word co-occurrence network for each document with a window of size 5. Human keywords were stemmed too, but they were not POS-filtered, i.e., they contained verbs. The average number of nodes, edges, and diameter of the networks were respectively 32, 155, and 3.6. For unweighted and weighted k-core, we retained as keywords the words belonging to the maximal k-core subgraph. Again, since our combination strategy was averaging, we rounded up the P&C scores to the nearest integer before extracting the main cores. For PageRank, we extracted the top 33% nodes as keywords. The following P&C parameters were grid searched: εa : {0, 0.1, 0.2, 0.3}, {ER, CL} and εd δw : {0, 1}. Excluding the εa = εd = 0 cases, this made for 180 combinations. Results. Performance is reported in terms of the usual macro- averaged precision, recall, and F1-score in Table III. The results for P&C are that obtained with the best parameter combination for each scoring function, reported in Table VII. {0, 0.1, 0.2, 0.3}, M : {8, 32, 96}, G : : TABLE III: Upper part: keyword extraction results. +% denotes percent improvement. Lower part: best results reported in SOTA unsupervised graph-based keyword extraction papers. s cu cw pr scores P&C original P&C original P&C original [Tixier16] [5] [Rousseau15] [29] [Mihalcea04] [26] precision 52.09 48.76 50.53 48.07 45.53 45.21 48.79 61.24 51.95 recall 51.25 46.90 48.54 46.81 42.73 41.89 72.78 50.32 54.99 7.45 F1-score +% 54.88 5.70 51.75 52.50 48.86 46.75 45.66 56.00 51.92 50.40 2.33 Like on social networks, using the P&C scores in place of the original scores improves performance for every algorithm, with large improvements ranging from 1.09 to 3.64 in F1- score. Even though looking at improvements is sufficient to show that our P&C strategy is effective, it is to be noted that our scores are on par with or exceed the state-of-the- 1https://github.com/snkim/AutomaticKeyphraseExtraction 0.250.50.7511.251.51.752EmailEnrontop p% best spreaders50607080originalP&C0.250.50.7511.251.51.752Epinionstop p% best spreaders304050607080900.250.50.7511.251.51.752WikiVotetop p% best spreaders30405060708090 art (SOTA) in the field of unsupervised graph-based keyword extraction, as shown in the lower part of Table III. V. Theoretical analysis We now try to understand why P&C for networks is effective from a theoretical perspective. The notation used in this section is summarized in Table IV. Underlying graph. Let us assume the existence of a true but unavailable underlying graph G∗, of which the available graph G is a snapshot, or sample, so that G features the same nodes as G∗ but has a slightly different edge set. This is analogous to the traditional assumption made in statistics that a given dataset represents a sample of a true but unknown distribution. Since G∗ is unavailable, we have to find a way to emulate sampling from G∗ by using only G. The solution we opt for is to perturb G. G(V, E) vi ∈ V G∗ G ∼ G∗ Gm ∼ G { G} s : V (cid:55)→ RV sG(i) R = {l(1), . . . , l(n)} R Rm MET TABLE IV: Notation summary. undirected weighted graph, n = V the i-th vertex of G, i ∈ {1, . . . , n} true (unknown) graph underlying G available graph (sample, snapshot of G∗) m-th perturbed version of G set of M perturbed graphs { G}M vertex scoring function, e.g., k-core algorithm score of vertex vi in G true ranking on G ranking when s is applied on G, estimate of R ranking when s is applied on Gm; estimate of R goodness of fit of R w.r.t. R m=1 ranking R = {l(1), . . . , l(n)} of the nodes (cid:8)v1, . . . , vn True ranking. Let us also assume the existence of a true (cid:9) of G in terms of their spreading capability, that associates each node vi with one of K labels l(i). vi is ranked before v j if l(i) > l( j). K ≤ n as some nodes may be equally good spreaders. This true ranking can be a given, or can be computed, for instance with the SIR model. Objective. Let s : V (cid:55)→ RV be a vertex scoring function, i.e., a function that associates each node of G with a real number, and let R be the ranking induced by s on the nodes of G. R can be seen as an estimate of the true ranking R, and s as an estimator. Let us also assume that the quality of the estimate provided by s (goodness of fit) is measured by a metric MET accepting R and R as input and taking values in (cid:2)0, 1(cid:3). The objective of s is to maximize MET. MET is a random variable (RV) as R is a RV. Perturbation as sampling. In each of the M edge-perturbed version Gm of G, the individual node scores, and by extension the rankings Rm, randomly vary, as our perturbation strategy is stochastic. We can thus consider the Rm to be RVs. Moreover, since the Gm are generated independently, the Rm are indepen- dent. Therefore, perturbing G is akin to sampling independent realizations from the true underlying graph G∗. Scoring nodes based on different configurations of the original network is thus akin to estimating the true scores of the nodes based on more evidence (see App. B). Definitions: bias and variance of a vertex scoring function. Our goal is to study the impact of P&C on the goodness of fit of s. In regression, the error is traditionally decomposed into bias and variance terms. We adopt this framework and define in what follows the bias and variance of s. is an estimator of f , and we have the following well-known breakdown of expected squared error of the estimation into (squared) bias, variance, and irreducible error terms: In the regression setting, y = f (x) + , σ2 = var(cid:2)(cid:3), E(cid:2)(y − f (x))2(cid:3) = bias(cid:2) f (x)(cid:3)2 + var(cid:2) f (x)(cid:3) + σ2 bias(cid:2) f (x)(cid:3) = E(cid:2) f (x) − f (x)(cid:3) var(cid:2) f (x)(cid:3) = E(cid:2)(cid:0) f (x) − E(cid:2) f (x)(cid:3)(cid:1)2(cid:3) (2) (3) (4) f (5) The expectation is computed for different samples drawn from the same underlying distribution. By analogy, in our setting, we can define the bias and variance of s as: bias(cid:2)s(cid:3) = E(cid:2)1 − MET(cid:3) = 1 − E(cid:2)MET(cid:3) var(cid:2)s(cid:3) = E(cid:2)(cid:0)MET − E(cid:2)MET(cid:3)(cid:1)2(cid:3) (6) The bias captures, on average, how close the estimated ranking R provided by s is to the true ranking R (for which MET is equal to 1), while the variance measures the instability of R (variability around its mean). The expectation is to be understood as computed over a set of observations of G∗. Since for all RVs X, Y and k ∈ R, E(cid:2)X + Y(cid:3) = E(cid:2)X(cid:3) + E(cid:2)Y(cid:3), E(cid:2)k(cid:3) = k, and E(cid:2)kX(cid:3) = kE(cid:2)X(cid:3), developing Eq. 6 gives: var(cid:2)s(cid:3) = E(cid:2)MET2 − 2E(cid:2)MET(cid:3)MET + E2(cid:2)MET(cid:3)(cid:3) = E(cid:2)MET2(cid:3) − 2E2(cid:2)MET(cid:3) + E2(cid:2)MET(cid:3) bias2(cid:2)s(cid:3) + var(cid:2)s(cid:3) = 1 − 2E(cid:2)MET(cid:3) + E(cid:2)MET2(cid:3) Summing the squared bias and variance terms thus gives: (7) (8) = E(cid:2)(cid:0)MET − 1(cid:1)2(cid:3) (9) (10) which can be interpreted as the expectation of the squared error, like in the case of regression. The proof of Eq. 9 is given in App. A. Theorem: P&C reduces error. Proof. Recall that the P&C score spc of node vi is defined as the average of the scores its gets in each of the M perturbed graphs { G} = { Gm}M m=1 generated from G: spc(vi) = s Gm(vi) 1 M M(cid:88) Rpc = E(cid:8) G(cid:9)(cid:2)(cid:8) R(cid:9)(cid:3) m=1 (11) (12) By definition, we can also write: where (cid:8) R(cid:9) = { Rm}M m=1. That is, the P&C estimate Rpc of the true ranking R is the average of the estimates Rm over the M perturbed graphs. Similarly, the goodness of fit of the P&C ranking can be written: where MET(cid:0)(cid:8) R(cid:9), R(cid:1) is simply written MET for readability. Thus, evaluating Eq. 9 over(cid:8) G(cid:9), and using Eq. 13 above: (13) METpc = E(cid:8) G(cid:9)(cid:2)MET(cid:3) (14) E(cid:8) G(cid:9)(cid:2)(cid:0)MET − 1(cid:1)2(cid:3) = 1 − 2E(cid:8) G(cid:9)(cid:2)MET(cid:3) + E(cid:8) G(cid:9)(cid:2)MET2(cid:3) = 1 − 2METpc + E(cid:8) G(cid:9)(cid:2)MET2(cid:3) Plus, since for all RV X and k ∈ R, E2(cid:2)X(cid:3) ≥ E(cid:2)X2(cid:3) and E(cid:2)k(cid:3) = E(cid:8) G(cid:9)(cid:2)(cid:0)MET − 1(cid:1)2(cid:3) ≥ 1 − 2METpc + E2(cid:8) G(cid:9)(cid:2)MET(cid:3) ≥(cid:0)1 − METpc (cid:1)2 E(cid:8) G(cid:9)(cid:2)(cid:0)MET − 1(cid:1)2(cid:3) ≥ E(cid:8) G(cid:9)(cid:2)(cid:0)1 − METpc k, using again Eq. 13, and since E is monotone: (17) (18) (cid:1)2(cid:3) (15) (16) Inequality 18 shows that the mean squared error of P&C (RHS) is always lower than or equal to the original mean squared error (LHS), which is an important result. Improve- (cid:3) ment can come from reducing bias and/or variance. Sample bias and variance. To understand how Inequality 18 holds in practice, we randomly selected 16 Hulth2003 word networks, and generated 50 perturbed version of each. As previously explained, this can be considered as drawing 50 independent realizations from the underlying graph that generated each network. With unweighted k-core, we then scored the nodes of each graph in the sample with and without using our P&C strategy, and computed the goodness of fit of each ranking, using the Normalized Discounted Cumulative Gain (NDCG) [30] as the metric MET. The NDCG is a standard metric for assessing ranking quality in Information Retrieval (IR). In our case, the more of the most influential spreaders are placed on top of R, the better the NDCG. More precisely, NDCG is computed as DCG/IDCG, where DCG is the Discounted Cumulative Gain computed on R and IDCG is the ideal DCG computed on R. NDCG is maximal and equal to 1 if R matches R exactly. Generally in IR, the DCG is computed over a shortlist of the best results, but we can assume without loss of generality that it is computed over the full list of n nodes: n(cid:88) i=1 2reli − 1 log2(i + 1) DCG = (19) where i designates the rank of node vi in the list. We used as the relevance score reli of vi its SIR influence, i.e., the average number of nodes infected at the end of multiple epidemics triggered from it. We finally computed bias and variance from the set of 50 NDCGs by using Eq. 5 and Eq. 6. We repeated the same procedure for the WIKIVOTE network. Results are shown in Table V. As can be seen for word networks, P&C reduces both bias and variance, although its major contribution appears to lie in the consistent reduction of bias. The average of the averages of the NDCGs is 0.58 for the rankings obtained with the original scores and 0.73 for P&C, which means that the rankings returned by the P&C scores fit the true rankings much better. On WIKIVOTE, P&C reduces bias, but not variance, which is initially very low. The P&C NDCG is 0.203 while the original is 0.189, indicating again that P&C returns better rankings. bias var TABLE V: Left and middle tables: sample bias (×102) and variance (×103) for 16 randomly selected word networks. Right: sample bias (×102) and variance (×105) for WIKIVOTE. Lower is better. original P&C 81.08 79.68 bias var 0.64 0.00 bias var bias var bias var bias var bias var bias var bias var original P&C 24.92 37.06 1.17 4.78 16.66 41.92 4.72 12.83 35.64 48.44 5.43 6.02 30.23 42.86 0.08 4.44 31.23 45.16 4.09 0.03 38.97 64.56 4.04 1.87 14.05 24.75 0.58 2.52 19.00 31.72 0.58 6.78 original P&C 34.97 51.59 1.16 0.66 27.22 39.16 1.79 0.04 54.66 66.43 0.76 0.09 21.98 46.97 1.54 2.71 20.75 26.40 0.49 0.04 24.40 37.29 2.17 0.27 18.68 33.76 0.18 2.50 24.12 41.61 6.60 6.85 bias var bias var bias var bias var bias var bias var bias var bias var it P&C for networks differs from bagging. Our P&C strategy reducing mainly bias rather than variance suggests that it differs from bootstrap aggregation (bagging). Indeed, bagging can increase variance when it fails [31], but is widely accepted that it cannot significantly reduce bias, as illustrated by the fact that it does not work well with stable algorithms such as nearest-neighbors approaches [15]. Another obvious difference is that a bootstrap sample has always the same size as the original dataset, whereas in our case, a perturbed graph has as many edges as the original graph only when εa = εd. To strictly emulate bagging, we would need to adopt a dif- ferent framework in which we would draw edges from a true underlying distribution rather than graphs. The perturbation step would only consist in sampling edges with replacement from the original set of edges. Some edges would be selected more than once, while some edges would not be selected at all. In the final perturbed network, 63.2% of unique edges would carry over from the original network, but no new edge would be present. This would remove the need for the εa and εd parameters, at the cost of losing flexibility. The improvement brought by P&C would be obtained mainly by reducing variance as: var(cid:2) Rpc (cid:3) = var (cid:35) (cid:34) 1 M(cid:88) M(cid:88) var(cid:2) Rm Rm m=1 M m=1 = 1 M2 (cid:3) (20) The extent to which error would be reduced would thus only depend on the amount of uncorrelation among the rankings Rm, as correlation adds positive covariance terms to the RHS of Eq. 20, i.e., increases variance. In other words, if our approach was equivalent to bagging, it would only work for unstable vertex scoring functions. The fact that our procedure is effective even for PageRank, which is considered relatively stable [19], [20], corroborates the empirical findings that our method is capable of reducing bias in addition to variance. Rather than bagging, we think that our approach is more closely related to noise injection techniques such as the noisy and smoothed bootstrap [32], [33], and to data augmentation strategies. More generally, perturbing graphs could also be seen as a form of adversarial training [34]. VI. Discussion VIII. Acknowledgements Importance of parameters. As can be seen in Fig. 5, most -but not all- parameter combinations return scores that allow the identification of better spreaders than the original scores. This suggests that while P&C is relatively robust to the choice of parameter values, some optimization is necessary to get the most out of the procedure. Tables VI and VII) support this claim, by clearly showing that there is no single best combination of parameters across networks and vertex scoring functions. Nonetheless, depending on the graph and/or scoring function, some parameters seem more important than others. For instance, for cu, selecting edges uniformly at random (ER model) during perturbation tends to work better than selecting edges in a biased way (CL model), which is consistent with the fact that cu ignores edge weights, unlike cw and pr. For cw, generating many perturbed versions of the original network (large values of M) also seems advantageous. Further research and analysis should help us understand what are the crucial parameters for different settings (graph type, size, density, diameter, scoring function...) and what are good initial values for them, reducing the need for parameter tuning. P&C improves even the performance of PageRank. This was unexpected, as PageRank is believed to be stable to edge- based perturbations [19], [20]. The implication could be that our P&C procedure is beneficial to any node scoring function, not only unstable ones, or that PageRank features some level of instability. While our theoretical analysis supports the former implication (see section V), the latter is a legitimate possibility as well. It has indeed been suggested that the stability of PageRank depends on the network topology. E.g., PageRank is more stable for scale-free graphs like the Web than for random networks [35]. For word networks, adding edges is beneficial. Interestingly, for word co-occurrence networks, adding edges or increment- ing the weights of already existing edges seems much more important than deleting edges (εa ≥ εd), regardless of the scoring function. This is equivalent to copying and pasting words from/to the input text, which can be seen as a form of data augmentation. It could also be interpreted as having a sliding window of stochastic size featuring an additional masking mechanism such that edges are drawn between a subset only of the words in each instantiation of the window. Data augmentation and stochastic windows were proven very beneficial in Computer Vision and NLP [36], [37], so this could explain why εa ≥ εd works well with word networks. VII. Conclusion We proposed what is, to the best of our knowledge, the first application of the Perturb and Combine (P&C) strategy to graphs. Experiments on real-world networks reveal that P&C improves influential spreader detection performance for 3 vertex scoring functions. The P&C scores can be obtained at little extra cost via parallelization. Finally, a theoretical analysis sheds light on why our P&C strategy is effective, and suggests that it works mainly by reducing bias. This implies that P&C could be effective even for stable algorithms. We thank the four anonymous reviewers for their feedback. References [1] F. Hoppensteadt, Mathematical Theories of Populations: Deomgraphics, Genetics, and Epidemics. Siam, 1975, vol. 20. [2] J. Leskovec, L. A. Adamic, and B. A. Huberman, "The dynamics of viral marketing," ACM Transactions on the Web (TWEB), vol. 1, no. 1, p. 5, 2007. [3] S. Pei, L. Muchnik, J. S. Andrade Jr, Z. Zheng, and H. A. Makse, "Searching for superspreaders of information in real-world social me- dia," Scientific reports, vol. 4, p. 5547, 2014. [4] K. Balog, L. Azzopardi, and M. De Rijke, "Formal models for expert finding in enterprise corpora," in Proceedings of the 29th annual international ACM SIGIR conference on Research and development in information retrieval. ACM, 2006, pp. 43 -- 50. [5] A. Tixier, F. Malliaros, and M. Vazirgiannis, "A graph degeneracy-based approach to keyword extraction," in Proceedings of the 2016 Conference on Empirical Methods in Natural Language Processing, 2016, pp. 1860 -- 1870. [6] M. Kitsak, L. K. Gallos, S. Havlin, F. Liljeros, L. Muchnik, H. E. Stanley, and H. A. Makse, "Identification of influential spreaders in complex networks," Nature physics, vol. 6, no. 11, pp. 888 -- 893, 2010. [7] G. F. De Arruda, A. L. Barbieri, P. M. Rodríguez, F. A. Rodrigues, Y. Moreno, and L. da Fontoura Costa, "Role of centrality for the identification of influential spreaders in complex networks," Physical Review E, vol. 90, no. 3, p. 032812, 2014. [8] F. D. Malliaros, M.-E. G. Rossi, and M. Vazirgiannis, "Locating influ- ential nodes in complex networks," Scientific reports, vol. 6, p. 19307, 2016. [9] F. Malliaros, C. Giatsidis, A. Papadopoulos, and M. Vazirgiannis, "The core decomposition of networks: Theory, algorithms and applications," 2019. [10] S. B. Seidman, "Network structure and minimum degree," Social net- works, vol. 5, no. 3, pp. 269 -- 287, 1983. [11] V. Batagelj and M. Zaveršnik, "Generalized cores," arXiv preprint cs/0202039, 2002. [12] A. Adiga and A. K. S. Vullikanti, "How robust is the core of a network?" in Joint European Conference on Machine Learning and Knowledge Discovery in Databases. Springer, 2013, pp. 541 -- 556. [13] A. V. Goltsev, S. N. Dorogovtsev, and J. F. F. Mendes, "k-core (bootstrap) percolation on complex networks: Critical phenomena and nonlocal effects," Physical Review E, vol. 73, no. 5, p. 056101, 2006. [14] L. Breiman, "Bias, variance, and arcing classifiers," 1996. [15] -- -- , "Bagging predictors," Machine learning, vol. 24, no. 2, pp. 123 -- 140, 1996. 2001. [16] -- -- , "Random forests," Machine learning, vol. 45, no. 1, pp. 5 -- 32, [17] P. Erdös and A. Rényi, "On the evolution of random graphs," Publ. Math. Inst. Hung. Acad. Sci, vol. 5, pp. 17 -- 61, 1960. [18] F. Chung and L. Lu, "The average distances in random graphs with given expected degrees," Proceedings of the National Academy of Sciences, vol. 99, no. 25, pp. 15 879 -- 15 882, 2002. [19] I. C. Ipsen and R. S. Wills, "Mathematical properties and analysis of googleâ A ´Zs pagerank." [20] A. Y. Ng, A. X. Zheng, and M. I. Jordan, "Link analysis, eigenvectors and stability," in International Joint Conference on Artificial Intelligence, vol. 17, no. 1. LAWRENCE ERLBAUM ASSOCIATES LTD, 2001, pp. 903 -- 910. [21] L. Page, S. Brin, R. Motwani, and T. Winograd, "The pagerank citation ranking: Bringing order to the web." Stanford InfoLab, Tech. Rep., 1999. [22] J. Leskovec and A. Krevl, "SNAP Datasets: Stanford large network dataset collection," http://snap.stanford.edu/data, Jun. 2014. [23] B. Klimt and Y. Yang, "The enron corpus: A new dataset for email classification research," ECML '04: Proceedings of the 15th European Conference on Machine Learning, pp. 217 -- 226, 2004. [24] W. O. Kermack and A. G. McKendrick, "Contributions to the mathe- matical theory of epidemics. ii. the problem of endemicity," vol. 138, no. 834. JSTOR, 1932, pp. 55 -- 83. [25] D. Chakrabarti, Y. Wang, C. Wang, J. Leskovec, and C. Faloutsos, "Epi- demic thresholds in real networks," ACM Transactions on Information and System Security (TISSEC), vol. 10, no. 4, pp. 1:1 -- 1:26, 2008. Fig. 5: Left: distribution of epidemic severity for the 120 parameter combinations on EPINIONS. Right: distribution of macro-averaged F1-score for the 180 parameter combinations on Hulth2003. Horizontal lines indicate performance when using original scores. TABLE VI: Top 5 best P&C parameters for each scoring function, in terms of number of nodes infected, on the social networks. N O R N E δw 0 1 0 1 1 S 1 1 N O 1 N 1 I P 1 E E 0 0 T O 1 V 0 K 0 W I I I G ER ER ER ER ER ER CL ER ER CL ER ER ER ER ER M 64 16 16 64 16 16 64 64 16 64 16 16 64 16 16 εd 0.2 0.2 0.05 0.2 0.05 0.2 0.2 0.2 0.1 0.2 0.2 0 0.05 0.1 0.2 εa 0.2 0.2 0.2 0.2 0.2 0.2 0.05 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.05 pr 2454 2454 2447 2446 2445 2598 2597 2596 2596 2593 596 595 594 593 593 cw 2641 2613 2663 2684 2649 2638 2654 2652 2631 2607 523 523 537 542 529 cu 2443 2444 2434 2437 2474 2391 2296 2388 2370 2310 474 463 465 450 461 δw 0 0 1 1 1 0 1 0 0 1 0 0 0 0 0 G CL CL CL CL ER ER CL ER ER CL ER CL CL CL CL M 64 64 64 64 64 64 64 64 64 64 64 64 64 64 64 εd 0.2 0.1 0.2 0.1 0.05 0.1 0.05 0.2 0.1 0.1 0.2 0.2 0.2 0.1 0.1 εa 0 0.1 0.2 0.1 0 0 0.05 0.05 0.2 0.1 0 0.05 0.1 0.1 0.05 cw 2724 2718 2717 2710 2709 2689 2673 2673 2672 2672 612 600 589 582 578 pr 2225 2343 2360 2364 2333 2553 2543 2552 2565 2573 584 574 584 573 581 cu 2456 2415 2426 2445 2444 2332 2246 2265 2324 2245 469 440 438 453 455 δw 1 1 0 0 0 1 1 1 1 1 1 1 1 1 1 G ER ER ER ER ER ER ER CL ER ER CL ER CL ER ER TABLE VII: Top 5 best P&C parameters for each scoring function, in terms of F1-score, on Hulth2003. cw 45.33 49.46 46.99 50.07 50.49 G M εd CL 0.0 CL 0.3 CL 0.0 CL 0.0 CL 0.2 G M εd ER 96 0.0 ER 0.0 8 ER 8 0.1 ER 32 0.0 ER 96 0.1 G M εd ER 0.1 8 ER 96 0.0 ER 96 0.3 ER 0.1 8 ER 32 0.0 cu 54.88 54.85 54.78 54.69 54.67 cw 52.50 52.38 52.38 52.31 51.78 cw 50.67 52.50 51.76 52.38 52.31 54.85 54.0.2 54.69 54.67 54.62 50.94 50.45 51.86 52.39 52.22 45.99 45.99 45.65 46.06 45.90 45.99 45.52 46.06 45.90 46.20 εa 0.3 0.3 0.3 0.3 0.3 cu pr εa 0.3 0.3 0.3 0.3 0.3 εa 0.3 0.3 0.3 0.3 0.3 δw 1 0 1 0 0 δw 0 0 0 0 0 pr δw 1 0 1 0 0 M 64 64 64 64 64 16 16 64 16 16 16 64 16 16 16 32 32 8 32 32 εd 0.2 0.2 0.1 0.05 0.1 0.2 0.2 0.2 0.2 0.2 0.05 0.2 0.1 0.1 0.05 εa 0.05 0.1 0.1 0.05 0.05 0.05 0.1 0 0 0.2 0.05 0.05 0 0 0 pr 2349 2419 2409 2422 2321 2574 2581 2573 2557 2598 575 578 581 572 576 cu 2538 2529 2521 2513 2508 2436 2436 2423 2419 2391 490 488 487 487 485 cu cw 2666 2525 2675 2625 2551 2653 2646 2667 2653 2638 532 555 530 529 530 pr 46.75 46.57 46.53 46.47 46.45 [26] R. Mihalcea and P. Tarau, "TextRank: bringing order into texts," in Proceedings of the 2004 Conference on Empirical Methods in Natu- ral Language Processing (EMNLP). Association for Computational Linguistics, 2004. [27] A. Tixier, K. Skianis, and M. Vazirgiannis, "Gowvis: a web application for graph-of-words-based text visualization and summarization," Pro- ceedings of ACL-2016 System Demonstrations, pp. 151 -- 156, 2016. [28] A. Hulth, "Improved automatic keyword extraction given more linguistic knowledge," in Proceedings of the 2003 Conference on Empirical Methods in Natural Language Processing (EMNLP). Association for Computational Linguistics, 2003, pp. 216 -- 223. [29] F. Rousseau and M. Vazirgiannis, "Main core retention on graph-of- words for single-document keyword extraction," in European Conference on Information Retrieval. Springer, 2015, pp. 382 -- 393. [30] K. Järvelin and J. Kekäläinen, "Cumulated gain-based evaluation of ir techniques," ACM Transactions on Information Systems (TOIS), vol. 20, no. 4, pp. 422 -- 446, 2002. [31] Y. Grandvalet, "Bagging equalizes influence," Machine Learning, vol. 55, pp. 251 -- 270, 2004. [32] Y. Raviv and N. Intrator, "Bootstrapping with noise: An effective regularization technique," Connection Science, vol. 8, no. 3-4, pp. 355 -- 372, 1996. [33] B. W. Silverman, Density estimation for statistics and data analysis. Routledge, 1986. [34] D. Zügner, A. Akbarnejad, and S. Günnemann, "Adversarial attacks on neural networks for graph data," arXiv preprint arXiv:1805.07984, 2018. [35] G. Ghoshal and A.-L. Barabási, "Ranking stability and super-stable nodes in complex networks," Nature communications, vol. 2, p. 394, 2011. [36] A. Krizhevsky, I. Sutskever, and G. E. Hinton, "Imagenet classification with deep convolutional neural networks," in Advances in neural infor- mation processing systems, 2012, pp. 1097 -- 1105. [37] T. Mikolov, K. Chen, G. Corrado, and J. Dean, "Efficient estimation of word representations in vector space," arXiv preprint arXiv:1301.3781, 2013. [38] D. Lusseau, "The emergent properties of a dolphin social network," Proceedings of the Royal Society of London B: Biological Sciences, vol. 270, no. Suppl 2, pp. S186 -- S188, 2003. Appendix A: proof of Equation 9 We start by summing the squared bias and the variance (bias and variance have been defined in Equations 5 and 6): bias2(cid:2) R(cid:3)+var(cid:2) R(cid:3) =(cid:0)1−E(cid:2)MET(cid:3)(cid:1)2+E(cid:2)(cid:0)MET−E(cid:2)MET(cid:3)(cid:1)2(cid:3) (21) Developing the left term of the right-hand side gives: LRHS = 1 − 2E(cid:2)MET(cid:3) + E2(cid:2)MET(cid:3) (22) term of the right-hand side gives: Since the expected value of a sum of random variables is equal to the sum of their expected values, the expected value of a constant is equal to that constant, and for all random variable X and λ ∈ R, E(cid:2)λX(cid:3) = λE(cid:2)X(cid:3), developing the right RRHS = E(cid:2)MET2 − 2E(cid:2)MET(cid:3)MET + E2(cid:2)MET(cid:3)(cid:3) = E(cid:2)MET2(cid:3) − 2E2(cid:2)MET(cid:3) + E2(cid:2)MET(cid:3) bias2(cid:2) R(cid:3) + var(cid:2) R(cid:3) = LRHS + RRHS = 1 − 2E(cid:2)MET(cid:3) + E(cid:2)MET2(cid:3) = E(cid:2)(cid:0)MET − 1(cid:1)2(cid:3) We thus get: (23) (24) (25) (26) (27) (cid:3) Which gives us Eq. 9. 215022002250230023502400k−core258026002620264026602680weighted k−core2540256025802600PageRankk-coreweighted k-corePageRank0.500.510.520.530.540.550.460.470.480.490.500.510.520.4520.4540.4560.4580.4600.4620.464k-coreweighted k-corePageRank Appendix B: Example Note that we adopt here the theoretical framework introduced in Section V. In this framework, we consider node scoring functions. Such functions map each vertex to a score and as such provide a ranking of all the nodes in the network. This ranking is compared to the true ranking provided by the SIR model. Regardless of the node scoring function used, in this framework, a node with a score of 2 is considered twice as influential than a node with a score of 1. Look at the square and rectangle nodes in Fig. 6. In the original graph, the square node is a member of the main core (k = 4), but a quick visual inspection reveals that this node does not lie in the most central part of the network and is not strongly attached to the main core. With a degree of only 4, the square node is actually one of the weakest members of the main core, i.e., removing only one of its connections would suffice in decreasing its score. Fig. 6: SIR-based spreading influence of the nodes in a toy network. The table below shows the original ('orig.') and P&C scores of the square and rectangle nodes, for k-core. The P&C score of a node is the mean of its scores in each of the 8 perturbed graphs. Truth denotes the SIR influence. Note that scores and influence are in different units, only ratios (i.e., rankings) matter. orig. 4 1 square rectangle perturbed P&C truth 3 3 3 2 1 2 3 2 2.38 4.09 1 2 3 1 2 1 1 2 1.62 2.76 On the other hand, the rectangle node is part of the 1-core in the original network. This low score does not reflect the fact that this node has direct access to the most central part of the network through its single connection. Should an epidemic be triggered from that node, it would probably be more severe than its low score suggests. To sum up, based on the original scores, the square node is 4 times more influential than the rectangle node. This is far from reality, as the ratio of the true influence scores is only 4.09/2.76 = 1.48. Looking at the scores obtained by the square and rectangle nodes in 8 slightly perturbed versions of the original network (a few edges added/deleted at random), we can observe that the rectangle node gets higher scores in most perturbed graphs, whereas the square node gets lower scores most of the time. Using the average of these 8 scores instead of the original scores is much closer to the true ratio: 2.38/1.62 = 1.47. Note that since we both add and remove edges in our perturbation strategy, the square node could get higher scores, and the rectangle node could get lower scores (e.g., it could get disconnected, and get a score of 0). There are no constraints on the values node scores can take on. The fact that the rectangle node gets higher scores in most perturbed graphs, whereas the square node gets lower scores in most of them, is truly reflective of the positions of the nodes in the graph. llllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllllInfluence(0.434,2.3](2.3,4.16](4.16,6.01](6.01,7.87](7.87,9.72](9.72,11.6] Appendix C: illustration of the perturbation strategy Fig. 7: Top: original graph (upper left corner) and 5 perturbed versions of it (generated by the edge perturbation strategy presented in subsection III-B with εa = 0.1, εd = 0.3, G = ER, and δw = 0). Node colors indicate unweighted k-core numbers. Bottom: same, but with PageRank. For k-core, we observe quite some variability in the core numbers across the different versions of the graph: the average cosine similarity between the 6 rankings is 93.29%. This illustrates well the unstable nature of the k-core vertex scoring function. PageRank rankings are only slightly more stable (average cosine similarity of 94.54%). The real-world network used in this example is the well-known dolphins network [38]. llllllllllllllllllllllllllllllllllllllllllllllllllllllllllll1234llllllllllllllllllllllllllllllllllllllllllllllllllllllllllll0123llllllllllllllllllllllllllllllllllllllllllllllllllllllllllll1234llllllllllllllllllllllllllllllllllllllllllllllllllllllllllll0123llllllllllllllllllllllllllllllllllllllllllllllllllllllllllll01234llllllllllllllllllllllllllllllllllllllllllllllllllllllllllll1234llllllllllllllllllllllllllllllllllllllllllllllllllllllllllll(5.47,11.2](11.2,16.9](16.9,22.7](22.7,28.4](28.4,34.1]llllllllllllllllllllllllllllllllllllllllllllllllllllllllllll(2.46,8.2](8.2,13.9](13.9,19.6](19.6,25.3](25.3,31]llllllllllllllllllllllllllllllllllllllllllllllllllllllllllll(5.46,10.9](10.9,16.4](16.4,21.8](21.8,27.3](27.3,32.8]llllllllllllllllllllllllllllllllllllllllllllllllllllllllllll(2.54,8.24](8.24,13.9](13.9,19.6](19.6,25.2](25.2,30.9]llllllllllllllllllllllllllllllllllllllllllllllllllllllllllll(2.56,9.96](9.96,17.3](17.3,24.7](24.7,32](32,39.4]llllllllllllllllllllllllllllllllllllllllllllllllllllllllllll(5.47,11.2](11.2,16.9](16.9,22.7](22.7,28.4](28.4,34.1] Appendix D: word co-occurrence network example Fig. 8: Word co-occurrence network representation of document 1478 of the Hulth 2003 dataset. Only nouns and adjective are kept (and then stemmed). W = 5. The human keywords (stemmed) for this document are work, pace, effect, emg, activ, subject, discomfort, finger, flexor, type, speed, typist, muscl, recruit, pattern, kei, forc, skill, train. lllllllllllllllllllllllllllllllllllllllllllllactivactualadditapplicdiscomforteffectefficielectromyographelectromyographiemgexperiextensorfastestfatigufindfingerflexorforcimportincreaskeylaboratorimaximumminimmusclpaceparticippatternpotentirecruitregardrelatresearchresultsharpskillslowslowerspeedstudisubjectthresholdtraintypetypistCore numbers56789Edge weights12345The effects of work pace on within−participant and between−participant keying force, electromyography, and fatigue. A laboratory study was conducted to determine theeffects of work pace on typing force, electromyographic (EMG) activity, and subjectivediscomfort. We found that as participants typed faster, their typing force and finger flexor andextensor EMG activity increased linearly. There was also an increase in subjective discomfort,with a sharp threshold between participants' self−selected pace and their maximum typing speed.The results suggest that participants self−select a typing pace that maximizes typing speed andminimizes discomfort. The fastest typists did not produce significantly more finger flexor EMG activitybut did produce proportionately less finger extensor EMG activity compared with the slower typists. Wehypothesize that fast typists may use different muscle recruitment patterns that allow them to be moreefficient than slower typists atstriking the keys. In addition, faster typists do not experience more discomfortthan slow typists. These findings show that the relative pace of typing is more important than actual typingspeed with regard to discomfort and muscle activity. These results suggest that typists may benefit from skilltraining to increase maximum typing speed. Potential applications of this research includes skill training for typists.
1502.06671
1
1502
2015-02-24T01:43:59
Minfer: Inferring Motif Statistics From Sampled Edges
[ "cs.SI", "physics.soc-ph" ]
Characterizing motif (i.e., locally connected subgraph patterns) statistics is important for understanding complex networks such as online social networks and communication networks. Previous work made the strong assumption that the graph topology of interest is known, and that the dataset either fits into main memory or stored on disks such that it is not expensive to obtain all neighbors of any given node. In practice, researchers have to deal with the situation where the graph topology is unknown, either because the graph is dynamic, or because it is expensive to collect and store all topological and meta information on disk. Hence, what is available to researchers is only a snapshot of the graph generated by sampling edges from the graph at random, which we called a "RESampled graph". Clearly, a RESampled graph's motif statistics may be quite different from the underlying original graph. To solve this challenge, we propose a framework and implement a system called Minfer, which can take the given RESampled graph and accurately infer the underlying graph's motif statistics. We also use Fisher information to bound the error of our estimates. Experiments using large scale datasets show that our method to be accurate.
cs.SI
cs
Minfer: Inferring Motif Statistics From Sampled Edges Pinghui Wang1, John C.S. Lui2, and Don Towsley3 1Noah's Ark Lab, Huawei, Hong Kong 2Department of Computer Science and Engineering, The Chinese University of Hong Kong, Hong Kong 3Department of Computer Science, University of Massachusetts Amherst, MA, USA {wang.pinghui}@huawei.com, [email protected], [email protected] 5 1 0 2 b e F 4 2 ] I S . s c [ 1 v 1 7 6 6 0 . 2 0 5 1 : v i X r a ABSTRACT Characterizing motif (i.e., locally connected subgraph patterns) statis- tics is important for understanding complex networks such as on- line social networks and communication networks. Previous work made the strong assumption that the graph topology of interest is known, and that the dataset either fits into main memory or is stored on disk such that it is not expensive to obtain all neighbors of any given node. In practice, researchers have to deal with the situation where the graph topology is unknown, either because the graph is dynamic, or because it is expensive to collect and store all topo- logical and meta information on disk. Hence, what is available to researchers is only a snapshot of the graph generated by sam- pling edges from the graph at random, which we called a "RESam- pled graph". Clearly, a RESampled graph's motif statistics may be quite different from the underlying original graph. To solve this challenge, we propose a framework and implement a system called Minfer, which can take the given RESampled graph and accurately infer the underlying graph's motif statistics. We also use Fisher in- formation to bound the errors of our estimates. Experiments using large scale datasets show our method to be accurate. 1. INTRODUCTION Complex networks are widely studied across many fields of sci- ence and technology, from physics to biology, and from nature to society. Networks which have similar global topological features such as degree distribution and graph diameter can exhibit signif- icant differences in their local structures. There is a growing in- terest to explore these local structures (also known as "motifs"), which are small connected subgraph patterns that form during the growth of a network. Motifs have many applications, for exam- ple, they are used to characterize communication and evolution patterns in online social networks (OSNs) [7, 14, 39, 33], pattern recognition in gene expression profiling [28], protein-protein in- teraction prediction [3], and coarse-grained topology generation of networks [11]. For instance, 3-node motifs such as "the friend of my friend is my friend" and "the enemy of my enemy is my friend" are well known evolution patterns in signed (i.e., friend/foe) social networks. Kunegis et al. [14] considered the significance of motifs Permission to make digital or hard copies of all or part of this work for personal or classroom use is granted without fee provided that copies are not made or distributed for profit or commercial advantage and that copies bear this notice and the full citation on the first page. To copy otherwise, to republish, to post on servers or to redistribute to lists, requires prior specific permission and/or a fee. Copyright 20XX ACM X-XXXXX-XX-X/XX/XX ...$15.00. in Slashdot Zoo1 and how they impact the stability of signed net- works. Other more complex examples include 4-node motifs such as bi-fans and bi-parallels defined in [20]. Although motifs are important characteristics to help researchers to understand the underlying network, one major technical hurdle is that it is computationally expensive to compute motif frequen- cies since this requires one to enumerate and count all subgraphs in a network, and there exist a large number of subgraphs even for a medium size network with less than one million edges. For ex- ample, the graphs Slashdot [18] and Epinions [25], which contain approximately 1.0×105 nodes and 1.0×106 edges have more than 2.0 × 1010 4-node connected and induced subgraphs [36]. To ad- dress this problem, several sampling methods have been proposed to estimate the frequency distribution of motifs [13, 37, 4, 36]. All these methods require that the entire graph topology fit into mem- ory, or the existence of an I/O efficient neighbor query API avail- able so that one can explore the graph topology, which is stored on disk. In summary,previous work focuses on designing compu- tationally efficient methods to characterize motifs when the entire graph of interest is given. Figure 1: An example of the available RESampled G∗ and the underlying graph G. In practice the graph of interest may not be known, but instead the available dataset is a subgraph sampled from the original graph. This can be due to the following reasons: • Data collection: Sampling is inevitable for collecting a large dynamic graph given as a high speed stream of edges. For example, sampling is used to collect network traffic on back- bone routers in order to study the network graph where a node in the graph represents a host and an edge (u, v) repre- sents a connection from host u to host v, because capturing the entire traffic is prohibited due to the high speed traffic and 1www.slashdot.org 1 ?G*G limited resources (e.g. memory and computation) of network devices. • Data transportation: Sampling may also be required to re- duce the high cost of transporting an entire dataset to a re- mote data analysis center. • Memory and computation: Sometimes the graph of interest is given in a memory expensive format such as a raw text file, and may be too large to fit into memory. Moreover, it may be too expensive to preprocess and organize it on disk. In such cases, it may be useful to build a relatively small graph consisting of edges sampled from the graph file at random, and compute its motif statistics in memory. A simple example is given in Fig. 1, where the sampled graph G∗ is derived from the dataset representing G. In this work, we assume the available graph G∗ is obtained through random edge sampling (i.e, each edge is independently sampled with the same probability 0 ≤ p ≤ 1), which is popular and easy to implement in prac- tice. Formally, we denote the graph G∗ as a RESampled graph of G. One can easily see that a RESampled graph's motif statis- tics will differ from those of the original graph due to uncertainties introduced by sampling. For example, Fig. 2 shows that s∗ is a 4- node induced subgraph in the RESampled graph G∗, and we do not know from which original induced subgraph s in G that it derives. s could be any one of the five subgraphs depicted in Fig. 2. Figure 2: s∗ is a 4-node induced subgraph in the RESampled graph G∗, and s is the original induced subgraph of s∗ in the original graph G. Unlike previous methods [13, 37, 4, 36], we aim to design an ac- curate method to infer motif statistics of the original graph G from the available RESampled graph G∗. These previous methods focus on designing computationally efficient sampling methods based on sampling induced subgraphs in G to avoid the problem shown in Fig. 2. Hence they fail to infer the underlying graph's motif statis- tics from the given RESampled graph. The gSH method in [2] can be used to estimate the number of connected subgraphs from sam- pled edges. However it cannot be applied to characterize motifs, i.e., connected and induced subgraphs (or CISes), because motif statistics can differ from connected subgraphs' statistics. For ex- ample, Fig. 3 shows that 75% of a graph's 4-node connected sub- graphs are isomorphic to a 4-node line (i.e., the first motif in Fig. 4 (b)), while 50% of its 4-node CISes are isomorphic to a 4-node line. Contribution: Our contribution can be summarized as: To the best of our knowledge, we are the first to study and provide an accurate and efficient solution to estimate motif statistics from a given RESampled graph. We introduce a probabilistic model to study the relationship between motifs in the RESampled graph and in the underlying graph. Based on this model, we propose an accu- rate method, Minfer, to infer the underlying graph's motif statistics from the RESampled graph. We also provide a Fisher information 2 Figure 3: 4-node CISes vs. 4-node connected subgraphs. based method to bound the error of our estimates. Experiments on a variety of real world datasets show that our method can accurately estimate the motif statistics of a graph based on a small RESampled graph. This paper is organized as follows: The problem formulation is presented in Section 2. Section 3 presents our method (i.e. Min- fer) for inferring subgraph class concentrations of the graph under study from a given RESampled graph. Section 4 presents methods for computing the given RESampled graph's motif statistics. The performance evaluation and testing results are presented in Sec- tion 5. Section 6 summarizes related work. Concluding remarks then follow. 2. PROBLEM FORMULATION In this section, we first introduce the concept of motif concentra- tion, then we discuss the challenges of computing motif concentra- tions in practice. Denote the underlying graph of interest as a labeled undirected graph G = (V, E, L), where V is a set of nodes, E is a set of undirected edges, E ∈ V × V , and L is a set of labels lu,v as- sociated with edges (u, v) ∈ E. For example, we attach a label lu,v ∈ {→,←,↔} to indicate the direction of the edge (u, v) ∈ E for a directed network. Edges may have other labels too, for in- stance, in a signed network, edges have positive or negative labels to represent friend or foe relationship. If L is empty, then G is an unlabeled undirected graph, which is equivalent to the regular undirected graph. Motif concentration is a metric that represents the distribution of various subgraph patterns that appear in G. To illustrate, we show the 3-, 4- and 5-nodes subgraph patterns in Figs. 4, 5,and 6 re- spectively. To define motif concentration formally, we first need to introduce some notation. For ease of presentation, Table 1 depicts the notation used in this paper. An induced subgraph of G, G(cid:48) = (V (cid:48), E(cid:48), L(cid:48)), V (cid:48) ⊂ V , E(cid:48) ⊂ E and L(cid:48) ⊂ L, is a subgraph whose edges and associated labels are all in G, i.e. E(cid:48) = {(u, v) : u, v ∈ V (cid:48), (u, v) ∈ E}, L(cid:48) = {lu,v : u, v ∈ V (cid:48), (u, v) ∈ E}. We define C (k) as the set of all connected induced subgraphs (CISes) with k nodes in G, and denote n(k) = C (k). For example, Fig. 3 depicts all possible 4-node CISes. Let s*s?abcdeabcdbcdebcdebcdebcdebcdeabcdbcdeabdeabceabdeabce4-node connected and induced subgraphs4-node connected subgraphsgraph of interest Table 1: Table of notations. i G = (V, E, L) is the graph under study G∗ = (V ∗, E∗, L∗) is a RESampled graph set of nodes for k-node CIS s set of edges for k-node CIS s associated motif of CIS s number of k-node motif classes i-th k-node motif set of k-node CISes in G set of CISes in G isomorphic to M (k) number of k-node CISes in G number of CISes in G isomorphic to M (k) number of CISes in G∗ isomorphic to M (k) concentration of motif M (k) matrix P = [Pij]1≤i,j≤Tk probability that a k-node CIS s∗ in G∗ isomorphic to M (k) given its original CIS s in G isomorphic to M (k) j number of subgraphs of M (k) to M (k) n(k) = (n(k) m(k) = (m(k) isomorphic in G )T j i i i i i 1 , . . . , n(k) )T Tk 1 , . . . , m(k) Tk i=1 m(k) i m(k) =(cid:80)Tk G G∗ V (s), s ∈ C (k) E(s), s ∈ C (k) M (s) i Tk M (k) C (k) C (k) i n(k) = C (k) n(k) i = C (k) i i m(k) (k) n i n(k) ω(k) i = P Pi,j φi,j n(k) m(k) m(k) m m(k) (k) i ρ(k) i = p q concentration of motif M (k) probability of sampling an edge q = 1 − p i in G∗ Tk denote the number of k-node motifs and M (k) denote the ith k- node motif. For example, T4 = 6 and M (4) are the six 4-node undirected motifs depicted in Fig. 4 (b). Then we partition C (k) into Tk equivalence classes, or C (k) , where CISes within C (k) are isomorphic to M (k) 1 , . . . , M (4) , . . . , C (k) Tk . 6 1 i i i Figure 6: All classes of three-node signed and undirected motifs (The numbers are the motif IDs). Let n(k) i denote the frequency of the motif M (k) ber of the CISes in G isomorphic to M (k) n(k) i = C (k) concentration of M (k) , which is the number of CISes in C (k) is defined as i i i i i , i.e., the num- . Formally, we have . Then the ω(k) i = n(k) i n(k) , 1 ≤ i ≤ Tk. is the fraction of k-node CISes isomorphic to the motif i among all k-node CISes. In this paper, we make the follow Thus, ω(k) M (k) assumptions: i • Assumption 1: The complete G is not available to us, but a RESampled graph G∗ = (V ∗, E∗, L∗) of G is given, where 3 V ∗ ∈ V , E∗ ∈ E, and L∗ are node, edge, and edge label sets of G∗ respectively. G∗ is obtained by random edge sampling, i.e., each edge in E is independently sampled with the same probability 0 < p < 1, where p is known in advance. • Assumption 2: The label of a sampled edge (u, v) ∈ G∗ is the same as that of (u, v) in G, i.e., l∗u,v = lu,v. These two assumptions are satisfied by many applications' data col- lection procedures. For instance, the source data of online applica- tions such as network traffic monitoring is given as a streaming of directed edges, and the following simple method is computa- tional and memory efficient for collecting edges and generating a small RESampled graph, which will be sent to remote network traffic analysis center: Each incoming directed edge u → v is sam- pled when τ (u, v) ≤ ρp, where ρ is an integer (e.g., 10,000) and τ (u, v) is a hash function satisfying τ (u, v) = τ (v, u) and map- ping edges into integers 0, 1, . . . , ρ − 1 uniformly. The property τ (u, v) = τ (v, u) guarantees that edges u → v and u ← v are sampled or discarded simultaneously. Hence the label of a sampled edge (u, v) ∈ E∗ is the same as that of (u, v) in G. Using universal hashing [5], a simple instance of τ (u, v) is given as the following function when each v ∈ V is an integer smaller than ∆ τ (u, v) = (a(min{u, v}∆+max{u, v})+b) mod γ mod ρ, where γ is a prime larger than ∆2, a and b are any integers with a ∈ {1, . . . , ρ − 1} and b ∈ {0, . . . , ρ − 1}. We can easily find that τ (u, v) = τ (v, u) and τ (u, v) maps edges into integers 0, 1, . . . , ρ − 1 uniformly. The computational and space complex- ities of the above sampling method are both O(1), which make it easy to use for data collections in practice. As alluded before, in this paper, we aim to accurately infer the motif concentrations of G based on the given RESampled graph G∗. 3. MOTIF STATISTICAL INFERENCE The motif statistics of RESampled graph G∗ and original graph G can be quite different. In this section, we introduce a probabilis- tic model to bridge the gap between the motif statistics of G∗ and G. Using this model, we will show there exists a simple and con- cise relationship between the motif statistics of G and G∗. We then propose an efficient method to infer the motif concentration of G from G∗. Finally, we also give a method to construct confidence intervals of our estimates of motif concentrations. 3.1 Probabilistic Model of Motifs in G∗ and G To estimate the motif statistics of G based on G∗, we develop a probabilistic method to model the relationship between the motifs in G∗ and G. Define P = [Pi,j] where Pi,j is the probability that s∗ is isomorphic to motif M (k) given that s is isomorphic to motif M (k) , i.e., Pi,j = P (M (s∗) = M (k) M (s) = M (k) . For example, M (3) j To obtain Pi,j, we first compute φi,j, which is the number of subgraphs of M (k) (i.e., 2 the triangle) includes three subgraphs isomorphic to M (3) (i.e., the wedge) for the undirected graph shown in Fig. 4 (a). Thus, we have φ1,2 = 3 for 3-node undirected motifs. When i = j, φi,j = 1. It is not easy to compute φi,j manually for 4- and 5-node motifs. Hence we provide a simple method to compute φi,j in Algorithm 1. The computational complexity is O(k2k!). Note that the cost of computing φi,j is not a big concern because in practice, k is usually five or less for motif discovery. Denote by V (s) and E(s) the sets of nodes and edges in subgraph s respectively. We have the isomorphic to M (k) ). 1 j j i i i 1++2+_3__4+++5++_6__+7___ (a) 3-node (b) 4-node Figure 4: All classes of three-node, four-node, and five-node undirected and connected motifs (The numbers are the motif IDs). (c) 5-node Figure 5: All classes of three-node directed and connected motifs (The numbers are the motif IDs). following equation 3.2 Motif Concentration Estimation (k) i (k) j )qE(M Pi,j = φi,jpE(M ), where q = 1−p. For all CISes in G isomorphic to M (k) , the above model tells us that approximately Pi,j × 100% of these CISes are expected to appear as CISes isomorphic to M (k) in G∗. )−E(M j i (k) i Using the above probabilistic model, we propose a method Min- fer to estimate motif statistics of G from G∗. Denote by m(k) , 1 ≤ i ≤ Tk, k = 3, 4, . . ., the number of CISes in G∗ isomorphic to the motif M (k) is presented in next section. Then, the expectation of m(k) . The method to compute m(k) is computed as i i i i i i j j . that are isomorphic to M (k) Algorithm 1: Pseudo-code of computing φi,j, i.e., the number of subgraphs of M (k) 1: Step 1: Generate two graphs G = ({v1, . . . , vk}, E, L) and G = ({u1, . . . , uk}, E, L), isomorphic to the motifs M (k) and M (k) respectively, where E and L are the edges and edge labels of nodes {v1, . . . , vk}, and E and L are the edges and edge labels of nodes {u1, . . . , uk}. 2: Step 2: Initialize a counter yi,j = 0. For each permutation (x1, . . . , xk) of integers 1, . . . , k, yi,j keeps unchanged when there exists an edge (va, vb) ∈ E satisfying (uxa , uxb ) /∈ E or lva,vb (cid:54)= luxa ,uxb (x1, . . . , xk) of integers 1, . . . , k, zj keeps unchanged when there exists an edge (va, vb) ∈ E satisfying (vxa , vxb ) /∈ E or lva,vb (cid:54)= lvxa ,vxb 3: Step 3: Initialize a counter zj = 0. For each permutation , and yi,j = yi,j + 1 otherwise. , and zj = zj + 1 otherwise. 4: Step 4: Finally, φi,j = yi,j/zj. E[m(k) i ] = (cid:88)1≤j≤Tk n(k) j Pi,j. (1) In matrix notation, Equation (1) can be expressed as E[m(k)] = P n(k), where P = [Pij]1≤i,j≤Tk, n(k) = (n(k) (m(k) )T. Then, we have 1 , . . . , m(k) Tk 1 , . . . , n(k) Tk )T, and m(k) = n(k) = P −1E[m(k)]. Thus, we estimate n(k) as n(k) = P −1m(k), where n(k) = (n(k) 1 , . . . , n(k) Tk )T. We easily have E[n(k)] = E[P −1m(k)] = P −1E[m(k)] = n(k), therefore n(k) is an unbiased estimator of n(k). Finally, we esti- 4 12 1 2 3 4 5 61 2 3 4 5 6 7 8 9 10 111213 14 15 16 17 18 19 20 21 1 2 3 4 5 6 78 9 10 11 12 13 mate ω(k) i as follows ω(k) i = n(k) j=1 n(k) j i(cid:80)Tk , 1 ≤ i ≤ Tk. (2) i (k) i the concentration of motif M (k) Denote by ρ(k) i = m m(k) . Then we observe that (2) is equivalent to the following equation, which directly describes the relationship between motif concentrations of G and G∗. Let ω = [ω(k) ]T and ρ = [ρ(k) 1 , . . . , ω(k) Tk in G∗, i.e., ρ(k) ]T 1 , . . . , ρ(k) Tk i ω = P −1ρ W , (3) where W = [1, . . . , 1]P −1ρ is a normalizer. For 3-node undi- rected motifs, P is computed as and the inverse of P is 0 3qp2 P =(cid:18) p2 p3 (cid:19) , P −1 =(cid:18) p−2 −3qp−3 p−3 (cid:19) . 0 Expressions for P and P −1 for 3-node signed undirected mo- tifs, 3-node directed motifs, 4-node undirected motifs, and 5-node undirected motifs can be found in Appendix. 3.3 Lower Bound on Estimation Errors It is difficult to directly analyze the errors of our estimate ω, be- cause it is complex to model the dependence of sampled CISes due to their shared edges and nodes. Instead, we derive a lower bound on the mean squared error (MSE) of ω using the Cramér-Rao lower bound (CRLB) of ω, which gives the smallest MSE that any unbi- ased estimator of ω can achieve. For a k-node CIS s selected from k-node CISes of G at random, the probability that s is isomorphic to the j-th k-node motif is P (M (s) = M (k) . Let s∗ be the induced subgraph of the node set V (s) in the RESampled graph G∗. Clearly, s∗ may not be connected. Furthermore there may exist nodes in V (s) that are not present in G∗. We say s∗ is evaporated in G∗ for these two scenarios. Let P0,j denote the probability that s∗ is evaporated given that its original CIS s is isomorphic to the j-th k-node motif. Then, we have ) = ω(k) j j P0,j = 1 − Pl,j. Tk(cid:88)l=1 For a random k-node CIS s of G, the probability that its associated s∗ in G∗ is isomorphic to the i-th k-node motif is ξi = P (M (s∗) = M (k) i ) = Tk(cid:88)j=1 Pi,jω(k) j , 1 ≤ i ≤ Tk, and the probability that s∗ is evaporated is ξ0 = Tk(cid:88)j=1 P0,jω(k) j . When s∗ is evaporated, we denote M (s∗) = 0. Then, the likeli- hood function of M (s∗) with respect to ω(k) is f (iω(k)) = ξi, 0 ≤ i ≤ Tk. The Fisher information of M (s∗) with respect to ω(k) is defined as a matrix J = [Ji,j]1≤i,j≤Tk, where Ji,j = E(cid:20) ∂ ln f (lω(k)) ∂ ln f (lω(k)) ∂ωi = ∂ ln f (lω(k)) (cid:21) ∂ ln f (lω(k)) ∂ωj ∂ωi ∂ωj Tk(cid:88)l=0 ξl = Tk(cid:88)l=0 Pl,iPl,j ξl . For simplicity, we assume that the CISes of G∗ are independent (i.e., none overlapping edges). Then the Fisher information matrix of all k-node CISes is n(k)J. The Cramér-Rao Theorem states that the MSE of any unbiased estimator is lower bounded by the inverse of the Fisher information matrix, i.e., MSE(ω(k) i ) = E[(ω(k) i − ω(k) i )2] ≥ (J−1)i,i − ω(k)(ω(k))T n(k) provided some weak regularity conditions hold [34]. Here the term ω(k)(ω(k))T corresponds to the accuracy gain obtained by account- ing for the constraint(cid:80)Tk i=1 ω(k) i = 1. 4. 3-, 4-, AND 5-NODE CIS ENUMERATION The existing generalized graph enumeration method [37] can be used for enumerating all k-node CISes in the RESampled graph G∗, however it is complex to apply and is inefficient for small val- ues of k = 3, 4, 5. In this section, we first present a method (an extension of the NodeIterator++ method in [29]) to enumerate all 3-node CISes in G∗. Then, we propose new methods to enumerate 4 and 5-node CISes in G∗ respectively. In what follows we denote N∗(u) as the neighbors of u in G∗. Note that in this section G∗ is the default graph when a function's underlying graph is omitted for simplicity. For example, the CIS with nodes u, v, and w refers to the CIS with nodes u, v, and w in G∗. 4.1 3-node CIS Enumeration Algorithm 2 shows our 3-node CISes enumeration method. Sim- ilar to the NodeIterator++ method in [29], we "pivot" (the associ- ated operation is discussed later) each node u ∈ V ∗ to enumerate CISes including u. For any two neighbors v and w of u, we can easily find that the induced graph s with nodes u, v and w is a 3- node CIS. Thus, we enumerate all pairs of two nodes in N∗(u), and update their associated 3-node CIS for u. We call this process "pivoting" u for 3-node CISes. Clearly, a 3-node CIS s is counted three times when the associ- ated undirected graph of s by discarding edge labels is isomorphic to a triangle, once by pivoting each node u, v, and w. Let (cid:31) be a total order on all of the nodes, which can be easily defined and obtained, e.g. from array position or pointer addresses. To ensure each CIS is enumerated once and only once, we let one and only one node in each CIS be "responsible" for making sure the CIS gets counted. When we "pivot" u and enumerate a CIS s, s is counted if u is the 'responsible" node of s. Otherwise, s is discarded and not counted. We use the same method in [27, 29], i.e., let the node with lowest order in a CIS whose associated undirected graph isomor- phic to a triangle be the "responsible" node. For the other classes of CISes, their associated undirected graphs are isomorphic to an unclosed wedge, i.e., the first motif in Fig. 4 (a). For each of these CISes, we let the node in the middle of its associated undirected graph (e.g., the node with degree 2 in the unclosed wedge) be the "responsible" node. 4.2 4-node CIS Enumeration Algorithm 3 shows our 4-node CISes enumeration method. To enumerate 4-node CISes, we "pivoting" each node u as follows: 5 Algorithm 2: 3-node CIS enumeration. input : G∗ = (V ∗, E∗, L∗) /* m(3) i records the number of CISes in G∗ Algorithm 3: 4-node CIS enumeration. input : G∗ = (V ∗, E∗, L∗) /* m(4) i records the number of CISes in G∗ isomorphic to motif M (3) i , 1 ≤ i ≤ T3. */ 1 , . . . , m(3) T3 )T isomorphic to motif M (4) i , 1 ≤ i ≤ T4. 1 , . . . , m(4) T4 )T output: m(4) = (m(4) for u ∈ V ∗ do for v ∈ N∗(u) do for w ∈ N∗(u) and w (cid:31) v do Γ = N∗(u) ∪ N∗(v) ∪ N∗(w) − {u, v, w}; for x ∈ Γ do continue(); if (u, x) ∈ E∗ and w (cid:31) x then end /* induced(G∗,{u, v, w, x}) is defined same as Alg. 2. s ← induced(G∗,{u, v, w, x}); /* undirected(s) returns the */ */ associated undirected graph of s by discarding edge labels. */ s ← undirected(s); /* findNodes(s, t) returns the set of nodes in V (s) having at least t neighbors in V (s). */ Λ ← findNodes(s, 2); if Λ ≥ 2 then /* minNodes(Λ) returns the node with the lowest order in V (s). */ if u (cid:31) minNodes(Λ) then end continue(); end i ← M (s); i ← m(4) m(4) i + 1; end end end end output: m(3) = (m(3) for u ∈ V ∗ do for v ∈ N∗(u) do for w ∈ N∗(u) and w (cid:31) v do /* induced(G∗, Γ) returns the CIS with the node set Γ of G∗. s ← induced(G∗,{u, v, w}); if (w, v) ∈ E∗ and u (cid:31) v then end /* M (s) is the motif class ID of continue(); */ */ s. i ← M (s); m(3) i ← m(3) i + 1; end end end For each pair of u's neighbors v and w where w (cid:31) v, we compute the neighborhood of u, v, and w , defined as Γ = N∗(u)∪N∗(v)∪ N∗(w) − {u, v, w}. For any node x ∈ Γ, we observe that the induced graph s consisting of nodes u, v, w, and x is a 4-node CIS. Thus, we enumerate each node x in Γ, and update the 4-node CIS consisting of u, v, w, and x. We repeat this process until all pairs of u's neighbors v and w are enumerated and processed. Similar to 3-node CISes, some 4-node CISes might be enumer- ated and counted more than once when we "pivoting" each node u as above. To solve this problem, we propose the following methods for making sure each 4-node CIS s is enumerated and gets counted once and only once: When (u, x) ∈ E∗ and w (cid:31) x, we discard x. Otherwise, denote by s the associated undirected graph of s by discarding edge labels. When s includes one and only one node u having at least 2 neighbors in V (s), we let u be the "responsible" of s. For example, the node 4 is the "responsible" node of the first subgraph in Fig. 7. When s includes more than one node having at least 2 neighbors in V (s), we let the node with lowest order among the nodes having at least 2 neighbors in V (s) be the "responsible" node of s. For example, the nodes 6 and 3 are the "responsible" nodes of the second and third subgraphs in Fig. 7. Figure 7: Examples of "responsible" nodes of 4-node CISs. Graphs shown are CISes' associated undirected graphs, and the number near to a node represents the node order. Red nodes are "responsible" nodes. 4.3 5-node CIS Enumeration Algorithm 4 describes our 5-node CISes enumeration method. For a 5-node CIS s, we classify it into two types according to its 6 associated undirected graph s: • 5-node CIS s with type 1: s has at least one node having more than two neighbors in V (s); • 5-node CIS s with type 2: s has no node having more than two neighbors in V (s), i.e., s is isomorphic to a 5-node line or a circle, i.e., the first or sixth motifs in Fig. 4 (c). We propose two different methods to enumerate these two types of 5-node CISes respectively. To enumerate 5-node CISes with type 1, we "pivoting" each node u as follows: When u has at least three neighbors, we enumerate each combination of three nodes v, w, x ∈ N∗(u) where x (cid:31) w (cid:31) v, and then compute the neighborhood of u, v, w, and x, defined as Γ ← N∗(u) ∪ N∗(v) ∪ N∗(w) ∪ N∗(x) − {u, v, w, x}. For any node y ∈ Γ, we observe that the induced graph s consisting of nodes u, v, w, x, and y is a 5-node CIS. Thus, we enumerate each node y in Γ, and update the associated 5-node CIS consisting of u, v, w, x, and y. We repeat this process until all combinations 437643764763 Algorithm 4: 5-node CIS enumeration. input : G∗ = (V ∗, E∗, L∗) /* m(5) i records the number of CISes in G∗ isomorphic to motif M (5) i , 1 ≤ i ≤ T5. */ output: m(5) = (m(5) /* The functions findNodes, minNodes, 1 , . . . , m(5) T5 )T induced, and undirected are defined in Algorithms 2 and 3. */ for u ∈ V ∗ do for v ∈ N∗(u) do for w ∈ N∗(u) and w (cid:31) v do /* Enumerate and update CIS s with undirected(s) not isomorphic to a 5-node line and circle. */ for x ∈ N∗(u) and x (cid:31) w do Γ ← N∗(u) ∪ N∗(v) ∪ N∗(w) ∪ N∗(x) − {u, v, w, x}; for y ∈ Γ do continue(); if (y, u) ∈ E∗ and x (cid:31) y then end s ← induced(G∗,{u, v, w, x, y}); s ← undirected(s); Λ ← findNodes(s, 3); if Λ ≥ 2 then if u (cid:31) minNodes(Λ) then end continue(); end i ← M (s); m(5) i ← m(5) i + 1; end end /* Enumerate and update s with undirected(s) isomorphic to a 5-node line or circle. if (u, v) /∈ E∗ then Γv ← N∗(v) − {u, w} − N∗(u) − N∗(w); for x ∈ Γv do /* s with undirected(s) */ isomorphic to a 5-node circle. */ Γw ← N∗(w)−{u, v}−N∗(u)−N∗(v); for y ∈ Γw do if (x, y) ∈ E∗ and u (cid:31) minNodes({u, v, w, x, y}) then continue(); end s ← induced(G∗,{u, v, w, x, y}); i ← M (s); i ← m(5) m(5) i + 1; of three nodes v, w, x ∈ N∗(u) are enumerated and processed. Similar to 4-node CISes, we propose the following method to make sure each 5-node s is enumerated and gets counted once and only once: When (y, u) ∈ E∗ and y (cid:31) x, we discard y. Otherwise, let s be the associated undirected graph of s, and we then pick the node with lowest order among the nodes having more than two neighbors in V (s) be the "responsible" node. The third and fourth subgraphs in Fig. 8 are two corresponding examples. To enumerate 5-node CISes with type 2, we "pivoting" each node u as follows: When u has at least two neighbors, we first enumerate each pair of u's neighbors v and w where (v, w) /∈ E∗. Then, we compute Γv defined as the set of v's neighbors not including u and w and not connecting to u and w, that is, Γv ← N∗(v)−{u, w}− N∗(u) − N∗(w). Similarly, we compute Γw defined as the set of w's neighbors not including u and v and not connecting to u and v, i.e., Γw ← N∗(w) − {u, v} − N∗(u) − N∗(v). Clearly, Γv ∩ Γw = ∅. For any x ∈ Γv and y ∈ Γw, we observe that the induced graph s consisting of nodes u, v, w, x, and y is a 5- node CIS with type 2. Thus, we enumerate each pair of x ∈ Γv and y ∈ Γw, and update the 5-node CIS consisting of u, v, w, x, and y. We repeat this process until all pairs of u's neighbors v and w are enumerated and processed. To make sure each CIS s is enumerated and gets counted once and only once, we let the node with lowest order be the "responsible" node when the associated undirected graph s of s isomorphic to a 5-node circle. When s is isomorphic to a 5-node line, we let the node in the middle of the line be the "responsible" node. The first and second subgraphs in Fig. 8 are two examples respectively. Figure 8: Examples of "responsible" nodes of 5-node CISs. Graphs shown are CISes' associated undirected graphs, and the number near to a node represents the node order. Red nodes are "responsible" nodes. 5. EVALUATION In this section, we first introduce our experimental datasets. Then we present results of experiments used to evaluate the performance of our method, Minfer, for characterizing CIS classes of size k = 3, 4, 5. 5.1 Datasets We evaluate the performance of our methods on publicly avail- able datasets taken from the Stanford Network Analysis Platform (SNAP)2, which are summarized in Table 2. We start by evaluat- ing the performance of our methods in characterizing 3-node CISes over million-node graphs: Flickr, Pokec, LiveJournal, YouTube, Web-Google, and Wiki-talk, contrasting our results with the ground truth computed through an exhaustive method. It is computation- ally intensive to calculate the ground-truth of 4-node and 5-nodes CIS classes in large graphs. For example, we can easily observe that a node with degree d > 4 is included in at least 1 6 d(d− 1)(d− 2www.snap.stanford.edu end end end end end end 7 43791437914379143791 Table 2: Graph datasets used in our simulations, "edges" refers to the number of edges in the undirected graph generated by discarding edge labels, "max-degree" represents the maximum number of edges incident to a node in the undirected graph. Graph Flickr [21] Pokec [30] LiveJournal [21] YouTube [21] Wiki-Talk [15] Web-Google [1] soc-Epinions1 [25] soc-Slashdot08 [18] soc-Slashdot09 [18] sign-Epinions [16] sign-Slashdot08 [16] sign-Slashdot09 [16] com-DBLP [38] com-Amazon [38] p2p-Gnutella08 [26] ca-GrQc [17] ca-CondMat [17] ca-HepTh [17] nodes 1,715,255 1,632,803 5,189,809 1,138,499 2,394,385 875,713 75,897 77,360 82,168 119,130 77,350 82,144 317,080 334,863 6,301 5,241 23,133 9,875 edges max-degree 15,555,041 22,301,964 48,688,097 2,990,443 4,659,565 4,322,051 405,740 469,180 504,230 704,267 416,695 504,230 1,049,866 925,872 20,777 14,484 93,439 25,937 27,236 14,854 15,017 28,754 100,029 6,332 3,044 2,539 2,552 3,558 2,537 2,552 343 549 97 81 279 65 i Table 3: Values of ω(3) , the concentrations of 3-node undirected and directed motifs. Flickr, Pokec, LiveJournal,Wiki-Talk, and Web-Google have 1.35×1010, 2.02×109, 6.90×109, 1.2×1010, and 7.00 × 108 3-node CISes respectively. (i is the motif ID.) Web- Google LiveLive- Wiki- Journal Talk Pokec Flickr i 1 2 1 2 3 4 5 6 7 8 9 10 11 12 13 9.60e-01 4.04e-02 2.17e-01 6.04e-02 1.28e-01 2.44e-01 1.31e-01 1.80e-01 5.69e-05 6.52e-03 1.58e-03 5.19e-03 6.46e-03 1.07e-02 9.86e-03 undirected 3-node motifs 9.84e-01 1.60e-02 9.55e-01 4.50e-02 9.99e-01 7.18e-04 directed 3-node motifs 1.77e-01 1.11e-01 1.60e-01 1.74e-01 1.91e-01 1.71e-01 7.06e-05 2.49e-03 1.03e-03 1.91e-03 2.03e-03 5.13e-03 3.45e-03 7.62e-02 4.83e-02 3.28e-01 1.14e-01 1.73e-01 2.15e-01 2.74e-05 8.66e-03 1.06e-03 6.63e-03 6.27e-03 9.82e-03 1.26e-02 8.91e-01 4.04e-02 3.91e-03 5.43e-02 5.48e-03 3.88e-03 1.37e-05 1.81e-04 8.42e-05 1.28e-04 8.03e-05 1.78e-04 6.65e-05 9.81e-01 1.91e-02 1.27e-02 1.60e-02 9.28e-01 3.09e-03 1.92e-02 1.92e-03 4.91e-05 6.82e-03 2.84e-04 2.77e-03 5.98e-03 1.21e-03 2.00e-03 2) 4-node CISes and 1 24 d(d−1)(d−2)(d−3) 5-node CISes, there- fore it requires more than O(1015) and O(1019) operations to enu- merate the 4-node and 5-node CISes of the Wiki-talk graph, which has a node with 100,029 neighbors. Even for a relatively small graph such as soc-Slashdot08, it takes almost 20 hours to compute all of its 4-node CISes. To solve this problem, the experiments for 4-node CISes are performed on four medium-sized graphs soc- Epinions1, soc-Slashdot08, soc-Slashdot09, com-DBLP, and com- Amazon, and the experiments for 5-node CISes are performed on four relatively small graphs ca-GR-QC, ca-HEP-TH, ca-CondMat, and p2p-Gnutella08, where computing the ground-truth is feasible. We also evaluate the performance of our methods for characteriz- ing signed CIS classes in graphs sign-Epinions, sign-Slashdot08, and sign-Slashdot09. 5.2 Error Metric In our experiments, we focus on the normalized root mean square error (NRMSE) to measure the relative error of the estimator ωi of the subgraph class concentration ωi, i = 1, 2, . . . . NRMSE(ωi) is defined as: NRMSE(ωi) = (cid:112)MSE(ωi) ωi , i = 1, 2, . . . , where MSE(ωi) is defined as the mean square error (MSE) of an estimate ω with respect to its true value ω > 0, that is MSE(ω) = E[(ω − ω)2] = var(ω) + (E[ω] − ω)2 . We note that MSE(ω) decomposes into a sum of the variance and bias of the estimator ω. Both quantities are important and need to be as small as possible to achieve good estimation performance. When ω is an unbiased estimator of ω, then we have MSE(ω) = var(ω) and thus NRMSE(ωi) is equivalent to the normalized stan- dard error of ωi, i.e., NRMSE(ωi) =(cid:112)var(ωi)/ωi. Note that our metric uses the relative error. Thus, when ωi is small, we consider values as large as NRMSE(ωi) = 1 to be acceptable. In all our ex- , the concentration estimates of 3- Table 4: NRMSEs of ω(3) node undirected motifs for p = 0.01 and p = 0.05 respectively. (i is the motif ID.) i Flickr Pokec 1.92e-03 4.56e-02 3.26e-03 6.92e-02 i 1 2 1 2 LiveLive- Wiki- Talk Journal p = 0.01 Web- Google 2.69e-03 1.64e-01 5.21e-03 2.67e-01 2.93e-04 4.00e-01 2.90e-04 6.90e-03 4.10e-04 8.68e-03 p = 0.05 2.64e-04 1.61e-02 6.06e-04 3.11e-02 2.92e-05 3.99e-02 periments, we average the estimates and calculate their NRMSEs over 1,000 runs. 5.3 Accuracy Results 5.3.1 Accuracy of inferring 3-node motifs' concen- trations Table 3 shows the real values of the 3-node undirected and di- rected motifs' concentrations for the undirected graphs and directed graphs of Flickr, Pokec, LiveJournal,Wiki-Talk, and Web-Google. Among all 3-node directed motifs, the 7-th motif exhibits the small- est concentration for all these five directed graphs. Here the undi- rected graphs are obtained by discarding the edge directions of directed graphs. Flickr, Pokec, LiveJournal,Wiki-Talk, and Web- Google have 1.35× 1010, 2.02× 109, 6.90× 109, 1.2× 1010, and 7.00× 108 3-node CISes respectively. Table 4 shows the NRMSEs of our estimates of 3-node undirected motifs' concentrations for p = 0.01 and p = 0.05 respectively. We observe that the NRM- SEs associated with the sampling probability p = 0.05 is about ten times smaller than the NRMSEs when p = 0.01. The NRMSEs are smaller than 0.04 when p = 0.05 for all five graphs. Fig. 9 shows 8 (a) p = 0.01 (b) p = 0.05 Figure 9: NRMSEs of ω(3) i , the concentration estimates of 3-node directed motifs for p = 0.01 and p = 0.05 respectively. , the concentrations of 3-node signed Table 5: Values of ω(3) and undirected motifs. Sign-Epinions, sign-Slashdot08, sign- Slashdot09 have 1.72 × 108, 6.72 × 107, and 7.25 × 107 3-node CISes respectively. (i is the motif ID.) i sign-Epinions sign-Slashdot08 sign-Slashdot09 i , the concentrations of 4-node undi- Table 6: Values of ω(4) rected motifs. Soc-Epinions1, soc-Slashdot08, soc-Slashdot09, and com-Amazon have 2.58 × 1010, 2.17 × 1010, 2.42 × 1010, and 1.78 × 108 4-node CISes respectively. (i is the motif ID.) i 1 2 3 4 5 6 7 6.69e-01 2.12e-01 9.09e-02 2.29e-02 2.76e-03 2.49e-03 3.81e-04 6.58e-01 2.32e-01 1.02e-01 5.86e-03 9.74e-04 1.14e-03 1.80e-04 6.68e-01 2.25e-01 9.96e-02 5.75e-03 9.34e-04 1.13e-03 1.76e-04 soc- Epinions1 3.24e-01 6.15e-01 2.78e-03 5.45e-02 3.01e-03 2.25e-04 soc- Slashdot08 2.93e-01 6.86e-01 1.25e-03 1.86e-02 7.77e-04 9.19e-05 soc- com- Slashdot09 Amazon 2.10e-01 2.90e-01 6.99e-01 6.89e-01 1.30e-03 2.37e-03 7.69e-02 1.84e-02 1.05e-02 8.48e-04 9.36e-05 1.55e-03 i 1 2 3 4 5 6 the NRMSEs of our estimates of 3-node directed motifs' concen- trations for p = 0.01 and p = 0.05 respectively. Similarly, we observe the NRMSEs when p = 0.05 are nearly ten times smaller than the NRMSEs when p = 0.01. The NRMSE of our estimates of ω(3) (i.e., the 7-th 3-node directed motif concentration) exhibits the largest error. Except for ω(3) 7 , the NRMSEs of the other motif 7 concentrations' estimates are smaller than 0.2 when p = 0.05. Table 5 shows the real values of 3-node signed motifs' concen- trations for Sign-Epinions, sign-Slashdot08, and sign-Slashdot09. Sign-Epinions, sign-Slashdot08, and sign-Slashdot09 have 1.72 × 108, 6.72× 107, and 7.25× 107 3-node CISes respectively. Fig. 10 shows the NRMSEs of our estimates of 3-node signed and undi- rected motifs' concentrations for p = 0.05 and p = 0.1 respec- 9 1234567891011121310−310−210−1100101motif IDError: NRMSE FlickrLiveJournalPokecWeb−GoogleWiki−Talk1234567891011121310−310−210−1100motif IDError: NRMSE FlickrLiveJournalPokecWeb−GoogleWiki−Talk i Table 7: Values of ω(5) , concentrations of 5-node undirected motifs. Com-Amazon, com-DBLP, p2p-Gnutella08, ca-GrQc, ca-CondMat, and ca-HepTh have 8.50 × 109, 3.34 × 1010, 3.92× 108, 3.64× 107, 3.32× 109, and 8.73× 107 5-node CISes respectively. (i is the motif ID.) com-A com- mazon DBLP 1.4e-1 2.9e-2 1.8e-1 7.5e-1 4.4e-1 1.6e-1 4.8e-2 6.0e-3 2.3e-3 1.1e-3 5.0e-5 3.6e-5 5.6e-2 1.5e-2 7.9e-2 3.5e-2 1.4e-3 4.2e-3 1.4e-4 1.7e-4 8.1e-3 7.3e-3 6.4e-3 5.3e-4 3.5e-6 8.2e-5 3.9e-4 5.2e-4 2.6e-2 6.7e-4 3.4e-4 7.1e-4 1.1e-5 3.9e-5 4.9e-6 2.3e-5 2.4e-4 2.8e-3 4.2e-4 5.8e-5 7.2e-6 7.9e-3 p2p-Gn ca- utella08 GrQc 9.8e-2 2.6e-1 5.2e-2 1.8e-1 2.1e-1 4.6e-1 1.0e-1 1.1e-2 2.7e-2 1.4e-3 9.2e-5 1.4e-3 1.1e-1 2.7e-2 1.2e-1 2.2e-2 1.4e-3 1.5e-2 6.5e-4 1.0e-3 2.3e-2 4.3e-3 2.3e-2 2.8e-4 4.5e-6 7.4e-4 1.7e-4 2.8e-3 1.5e-1 7.6e-5 1.4e-3 1.4e-4 4.3e-5 8.0e-5 2.3e-5 6.0e-6 1.5e-5 1.9e-2 8.0e-3 7.0e-7 1.5e-8 6.1e-2 i 1 2 3 4 5 6 7 8 9 10 11 12 13 14 15 16 17 18 19 20 21 ca-Con dMat 1.4e-1 2.2e-1 4.3e-1 4.9e-2 2.1e-3 1.1e-4 5.5e-2 8.0e-2 7.0e-3 3.0e-4 9.9e-3 4.5e-3 6.4e-6 6.6e-4 5.9e-3 9.2e-4 2.9e-5 8.5e-6 9.8e-4 1.4e-4 1.5e-4 ca- HepTh 2.6e-1 8.2e-2 4.4e-1 6.0e-2 5.4e-3 4.1e-4 6.4e-2 5.2e-2 8.4e-3 8.0e-4 1.0e-2 3.6e-3 3.5e-5 1.0e-3 5.3e-3 4.4e-4 8.4e-5 3.0e-5 5.8e-4 8.2e-5 3.2e-3 Except ω(4) mates are smaller than 0.2 for p = 0.2 . 3 , the NRMSEs of the other motif concentrations' esti- (a) p = 0.1 (b) p = 0.2 Figure 11: NRMSEs of ω(4) node undirected motifs for p = 0.1, and p = 0.2 respectively. , the concentration estimates of 4- i 5.3.3 Accuracy of inferring 5-node motifs' concen- trations i Table 7 shows the real values of ω(5) , i.e., the concentrations of 5-node undirected motifs for com-Amazon, com-DBLP, p2p- Gnutella08, ca-GrQc, ca-CondMat, and ca-HepTh. Com-Amazon, com-DBLP, p2p-Gnutella08, ca-GrQc, ca-CondMat, and ca-HepTh contains 8.50 × 109, 3.34 × 1010, 3.92 × 108, 3.64 × 107, 3.32 × 109, and 8.73 × 107 5-node CISes respectively. Fig. 12 shows the NRMSEs of ω(5) , the concentration estimates of 5-node undirected motifs for p = 0.1, p = 0.2, and p = 0.3 respectively. We observe that NRMSE decreases as p increases, and the 6-th, 10-th, 13-th, 17-th, 18-th 5-node motifs with small ω(5) exhibit large NRMSEs. 5.4 Error Bounds i i Figure 13 shows the root CRLBs (RCRLBs) and the root MSEs (RMSEs) of our estimates of 3-node directed motifs' concentra- tions, 4-, and 5-node undirected motifs' concentrations, where graphs LiveJournal, soc-Epinions, and com-DBLP are used for studying 3-node directed motifs, 4-, and 5-node undirected motifs respec- tively. We observe that the RCRLBs are smaller than the RMSEs, and fairly close to the RMSEs. The and RCRLBs are almost in- distinguishable for 3-node directed motifs, where p = 0.01 and LiveJournal is used. It indicates that the RCRLBs can efficiently bound the errors of our motif concentration estimations. 6. RELATED WORK There has been considerable interest to design efficient sampling methods for counting specific subgraph patterns such as triangles [31, 23, 12, 2], cliques [6, 9], and cycles [19], because it is computa- tionally intensive to compute the number of the subgraph pattern's appearances in a large graph. Similar to the problem studied in [13, 37, 22, 4, 36], in this work we focus on characterizing 3-, 4-, and 5-nodes CISes in a single large graph, which differs from the prob- lem of estimating the number of subgraph patterns appearing in a large set of graphs studied in [10]. OmidiGenes et al. [22] pro- posed a subgraph enumeration and counting method using sam- pling. However this method suffers from unknown sampling bias. To estimate subgraph class concentrations, Kashtan et al. [13] pro- posed a subgraph sampling method, but their method is compu- tationally expensive when calculating the weight of each sampled subgraph, which is needed to correct for the bias introduced by 10 tively. For all these three signed graphs, the NRMSEs are smaller than 0.9 and 0.2 when p = 0.05 and p = 0.1 respectively. (a) p = 0.05 (b) p = 0.1 Figure 10: NRMSEs of ω(3) , the concentration estimates of 3- node signed and undirected motifs for p = 0.05 and p = 0.1 respectively. i 5.3.2 Accuracy of inferring 4-node motifs' concen- trations i Table 6 shows the real values of ω(4) , i.e., the concentrations of 4-node undirected motifs for Soc-Epinions1, soc-Slashdot08, soc- Slashdot09, and com-Amazon. Soc-Epinions1, soc-Slashdot08, soc- Slashdot09, and com-Amazon have 2.58 × 1010, 2.17 × 1010, 2.42 × 1010, and 1.78 × 108 4-node CISes respectively. Fig. 11 shows the NRMSEs of ω(4) , the concentration estimates of 4-node undirected motifs for p = 0.05, p = 0.1, and p = 0.2 respectively. We observe that motifs with smaller ω(4) exhibit larger NRMSEs. i i 123456710−210−1100motif IDError: NRMSE sign−Epinionssign−Slashdot08sign−Slashdot09123456710−310−210−1100motif IDError: NRMSE sign−Epinionssign−Slashdot08sign−Slashdot0912345610−210−1100101motif IDError: NRMSE soc−Epinions1soc−Slashdot08soc−Slashdot09com−Amazon12345610−210−1100101motif IDError: NRMSE soc−Epinions1soc−Slashdot08soc−Slashdot09com−Amazon (a) soc-Amazon (b) soc-DBLP (c) p2p-Gnutella08 (d) ca-GrQc (e) ca-CondMat (f) ca-HepTh Figure 12: NRMSEs of ω(5) i , the concentration estimates of 5-node undirected motifs for p = 0.1, p = 0.2, and p = 0.3 respectively. sampling. To address this drawback, Wernicke [37] proposed an al- gorithm, FANMOD, based on enumerating subgraph trees to detect network motifs. Bhuiyan et al. [4] proposed a Metropolis-Hastings based sampling method GUISE to estimate 3-node, 4-node, and 5- node subgraph frequency distribution. Wang et al. [36] proposed an efficient crawling method to estimate online social networks' motif concentrations, when the graph's topology is not available in ad- vance and it is costly to crawl the entire topology. In summary, pre- vious methods focus on designing efficient sampling methods and crawling methods for estimating motif statistics when the graph is directly available or indirectly available (i.e., it is not expensive to query a node's neighbors [36]). They cannot be applied to solve the problem studied in this paper, i.e., we assume the graph is not avail- able but a RESampled graph is given and we aim to infer the under- lying graph's motif statistics from the RESampled graph. At last, we would like to point out our method of estimating motif statistics and its error bound computation method are inspired by methods of estimating flow size distribution for network traffic measurement and monitoring [8, 24, 32, 35]. 7. CONCLUSIONS To the best of our knowledge, we are the first to study the prob- lem of inferring the underlying graph's motif statistics when the en- tire graph topology is not available, and only a RESampled graph is given. We propose a model to bridge the gap between the under- lying graph's and its RESampled graph's motif statistics. Based on this probabilistic model, we develop a method Minfer to infer the underlying graph's motif statistics, and give a Fisher information based method to bound the error of our estimates. and experimen- tal results on a variety of known data sets validate the accuracy of our method. Appendix The matrixes P and P −1 is shown in Fig. 14. Acknowledgment We thank the anonymous reviewers as well as Dr. Wei Fan for helpful suggestions. 8. REFERENCES [1] Google programming contest. http: //www.google.com/programming-contest/, 2002. [2] N. Ahmed, N. Duffield, J. Neville, and R. Kompella. Graph sample and hold: A framework for big-graph analytics. In Proceedings of the 20th ACM SIGKDD International Conference on Knowledge Discovery and Data Mining, pages 589 -- 597, 2014. 11 13691215182110−2100102104motif IDRNMSE p=0.1p=0.2p=0.313691215182110−2100102104106motif IDError: NRMSE p=0.1p=0.2p=0.313691215182110−210−1100101102motif IDError: NRMSE p=0.1p=0.2p=0.313691215182110−1100102104106motif IDError: NRMSE p=0.1p=0.2p=0.313691215182110−2100102104motif IDError: RNMSE p=0.1p=0.2p=0.313691215182110−2100102104106motif IDError: NRMSE p=0.1p=0.2p=0.3 (a) (LiveJournal) 3-node directed motifs (b) (soc-Epinions) 4-node undirected motifs (c) (com-DBLP) 5-node undirected motifs Figure 13: RCRLBs and RMSEs of concentration estimates of 3, 4, and 5-node directed motifs. [3] I. Albert and R. Albert. Conserved network motifs allow protein -- protein interaction prediction. Bioinformatics, 4863(13):3346 -- 3352, 2004. [4] M. A. Bhuiyan, M. Rahman, M. Rahman, and M. A. Hasan. Guise: Uniform sampling of graphlets for large graph analysis. In Proceedings of IEEE ICDM 2012, pages 91 -- 100, December 2012. [5] J. Chen, W. Hsu, M.-L. Lee, and S.-K. Ng. Nemofinder: dissecting genome-wide protein-protein interactions with meso-scale network motifs. In Proceedings of ACM SIGKDD 2006, pages 106 -- 115, August 2006. [6] J. Cheng, Y. Ke, A. W.-C. Fu, J. X. Yu, and L. Zhu. Finding maximal cliques in massive networks. ACM Transactions on Database Systems, 36(4):21:1 -- 21:34, dec 2011. [7] H. Chun, Y. yeol Ahn, H. Kwak, S. Moon, Y. ho Eom, and H. Jeong. Comparison of online social relations in terms of volume vs. interaction: A case study of cyworld. In Proceedings of ACM SIGCOMM Internet Measurement Conference 2008, pages 57 -- 59, November 2008. [8] N. Duffield, C. Lund, and M. Thorup. Estimating flow distributions from sampled flow statistics. In Proceedings of ACM SIGCOMM 2003, pages 325 -- 336, August 2003. [9] M. Gjoka, E. Smith, and C. T. Butts. Estimating Clique Composition and Size Distributions from Sampled Network Data. ArXiv e-prints, Aug. 2013. [10] M. A. Hasan and M. J. Zaki. Output space sampling for graph patterns. In Proceedings of the VLDB Endowment 2009, pages 730 -- 741, August 2009. [11] S. Itzkovitz, R. Levitt, N. Kashtan, R. Milo, M. Itzkovitz, and U. Alon. Coarse-graining and self-dissimilarity of complex networks. Physica Rev.E, 71:016127, 2005. [12] M. Jha, C. Seshadhri, and A. Pinar. A space efficient streaming algorithm for triangle counting using the birthday paradox. In Proceedings of the 19th ACM SIGKDD International Conference on Knowledge Discovery and Data Mining, pages 589 -- 597, 2013. [13] N. Kashtan, S. Itzkovitz, R. Milo, and U. Alon. Efficient sampling algorithm for estimating subgraph concentrations and detecting network motifs. Bioinformatics, 20(11):1746 -- 1758, 2004. [14] J. Kunegis, A. Lommatzsch, and C. Bauckhage. The slashdot zoo: mining a social network with negative edges. In Proceedings of WWW 2009, pages 741 -- 750, April 2009. 12 [15] J. Leskovec, D. Huttenlocher, and J. Kleinberg. Predicting positive and negative links in online social networks. In Proceedings of WWW 2010, pages 641 -- 650, April 2010. [16] J. Leskovec, D. Huttenlocher, and J. Kleinberg. Signed networks in social media. In Proceedings of the 28th ACM Conference on Human Factors in Computing Systems (CHI), pages 1361 -- 1370, April 2010. [17] J. Leskovec, J. Kleinberg, and C. Faloutsos. Graph evolution: Densification and shrinking diameters. Transactions on Knowledge Discovery from Data (TKDD), 1(1), Mar. 2007. [18] J. Leskovec, K. J. Lang, A. Dasgupta, and M. W. Mahoney. Community structure in large networks: Natural cluster sizes and the absence of large well-defined clusters. Internet Mathematics, 6(1):29 -- 123, 2009. [19] M. Manjunath, K. Mehlhorn, K. Panagiotou, and H. Sun. Approximate counting of cycles in streams. In Proceedings of the 19th European Conference on Algorithms, ESA'11, pages 677 -- 688, Berlin, Heidelberg, 2011. Springer-Verlag. [20] R. Milo, E. Al, and C. Biology. Network motifs: Simple building blocks of complex networks. Science, 298(5549):824 -- 827, October 2002. [21] A. Mislove, M. Marcon, K. P. Gummadi, P. Druschel, and B. Bhattacharjee. Measurement and analysis of online social networks. In Proceedings of ACM SIGCOMM Internet Measurement Conference 2007, pages 29 -- 42, October 2007. [22] S. Omidi, F. Schreiber, and A. Masoudi-nejad. Moda: An efficient algorithm for network motif discovery in biological networks. Genes and Genet systems, 84(5):385 -- 395, 2009. [23] A. Pavany, K. T. S. Tirthapuraz, and K.-L. Wu. Counting and sampling triangles from a graph stream. In Proceedings of VLDB, pages 1870 -- 1881, 2013. [24] B. Ribeiro, D. Towsley, T. Ye, and J. Bolot. Fisher information of sampled packets: an application to flow size estimation. In Proceedings of ACM SIGCOMM IMC 2006, pages 15 -- 26, October 2006. [25] M. Richardson, R. Agrawal, and P. Domingos. Trust management for the semantic web. In Proceedings of the 2nd International Semantic Web Conference, pages 351 -- 368, October 2003. [26] M. Ripeanu, I. T. Foster, and A. Iamnitchi. Mapping the gnutella network: Properties of large-scale peer-to-peer systems and implications for system design. IEEE Internet Computing Journal, 6(1):50 -- 57, 2002. 05101510−610−410−23−node directed motif ID RMSE, p=0.01RMSE, p=0.05RCRLB, p=0.01RCRLB, p=0.0512345610−610−510−410−310−210−14−node undirected motif ID RMSE, p=0.05RMSE, p=0.1RCRLB, p=0.05RCRLB, p=0.1051015202510−310−210−11001015−node undirected motif ID RMSE, p=0.1RMSE, p=0.2RCRLB, p=0.1RCRLB, p=0.2 [27] T. Schank. Algorithmic Aspects of Triangle-Based Network Analysis. PhD thesis, 2007. [28] S. S. Shen-Orr, R. Milo, S. Mangan, and U. Alon. Network motifs in the transcriptional regulation network of escherichia coli. Nature Genetics, 31(1):64 -- 68, May 2002. [29] S. Suri and S. Vassilvitskii. Counting triangles and the curse of the last reducer. WWW 2011, pages 607 -- 614, 2011. [30] L. Takac and M. Zabovsky. Data analysis in public social networks. In International Scientific Conference and International Workshop Present Day Trends of Innovations, pages 1 -- 6, May 2012. [31] C. E. Tsourakakis, U. Kang, G. L. Miller, and C. Faloutsos. Doulion: Counting triangles in massive graphs with a coin. In PROCEEDINGS OF ACM KDD 2009, 2009. [32] P. Tune and D. Veitch. Towards optimal sampling for flow size estimation. In Proc. of the IMC, pages 243 -- 256, 2008. [33] J. Ugander, L. Backstrom, and J. Kleinberg. Subgraph frequencies: mapping the empirical and extremal geography of large graph collections. In Proceedings of the 22nd international conference on World Wide Web, WWW 2013, pages 1307 -- 1318, 2013. [34] H. L. van Trees. Estimation and Modulation Theory, Part 1. Wiley, New York, 2001. [35] P. Wang, X. Guan, J. Zhao, J. Tao, and T. Qin. A new sketch method for measuring host connection degree distribution. IEEE Transactions on Information Forensics and Security, 9(6):948 -- 960, 2014. [36] P. Wang, J. C. Lui, J. Zhao, B. Ribeiro, D. Towsley, and X. Guan. Efficiently estimating motif statistics of large networks. ACM Transactions on Knowledge Discovery from Data, 2014. [37] S. Wernicke. Efficient detection of network motifs. IEEE/ACM Transactions on Computational Biology and Bioinformatics, 3(4):347 -- 359, 2006. [38] J. Yang and J. Leskovec. Defining and evaluating network communities based on ground-truth. In 12th IEEE International Conference on Data Mining (ICDM), pages 745 -- 754, 2012. [39] J. Zhao, J. C. S. Lui, D. Towsley, X. Guan, and Y. Zhou. Empirical analysis of the evolution of follower network: A case study on douban. In Proceedings of IEEE INFOCOM NetSciCom 2011, pages 941 -- 946, April 2011. 13 (a) P of 3-node signed subgraph classes (b) P −1 of 3-node signed subgraph classes (c) P of 4-node undirected subgraph classes (d) P −1 of 4-node undirected subgraph classes (e) P of 3-node directed subgraph classes (f) P −1 of 3-node directed subgraph classes Figure 14: The matrixes P and P −1. 14 p2003qp2qp2000p2002qp22qp2000p200qp23qp2000p30000000p30000000p30000000p3p−200−3qp−3−qp−3000p−200−2qp−3−2qp−3000p−200−qp−3−3qp−3000p−30000000p−30000000p−30000000p−3p304qp32qp36q2p312q3p30p30qp32q2p34q3p300p40qp43q2p4000p44qp412q2p40000p56qp500000p6p−30−4qp−4−2qp−46q2p−5−12q3p−60p−30−qp−42q2p−5−4q3p−600p−40−qp−53q2p−6000p−4−4qp−512q2p−60000p−5−6qp−600000p−6p2000000qp200qp2000p200003qp2qp2qp2000000p20000qp20qp2000000p20000qp22qp20qp200000p2000qp202qp2qp2000000p200000qp23qp2000000p30000000000000p30000000000000p30000000000000p30000000000000p30000000000000p30000000000000p3p−2000000−qp−300−qp−3000p−20000−3qp−3−qp−3−qp−3000000p−20000−qp−30−qp−3000000p−20000−qp−3−2qp−30−qp−300000p−2000−qp−30−2qp−3−qp−3000000p−200000−qp−3−3qp−3000000p−30000000000000p−30000000000000p−30000000000000p−30000000000000p−30000000000000p−30000000000000p−3